diff --git a/bmas/README.md b/bmas/README.md index 08f650e..916b24c 100644 --- a/bmas/README.md +++ b/bmas/README.md @@ -68,8 +68,10 @@ SSE and AVX512 support exists to a limited extent due to limited developer time. | min | + | + | + | + | + | + | + | + | + | + | | max | + | + | + | + | + | + | + | + | + | + | | sum (horizontal) | + | + | + | + | + | + | - | - | - | - | -| min (horizontal) | + | + | + | + | + | + | + | + | + | + | -| max (horizontal) | + | + | + | + | + | + | + | + | + | + | +| hmin (horizontal) | + | + | + | + | + | + | + | + | + | + | +| hmax (horizontal) | + | + | + | + | + | + | + | + | + | + | +| himin (index of min) | + | + | + | + | + | + | + | + | + | + | +| himax (index of max) | + | + | + | + | + | + | + | + | + | + | | **Function \ Data type** | float32 | float64 | int64 | int32 | int16 | int8 | uint64 | uint32 | uint16 | uint8 | | lt | + | + | + | + | + | + | + | + | + | + | | le | + | + | + | + | + | + | + | + | + | + | diff --git a/bmas/bmas.c b/bmas/bmas.c index 3f8cd65..7136016 100644 --- a/bmas/bmas.c +++ b/bmas/bmas.c @@ -98,6 +98,7 @@ void static inline BMAS_ivec_store_multi( #include "cast.h" #include "copy.h" #include "one_arg_reduce_fn_body.h" +#include "one_arg_ireduce_fn_body.h" #include "dot_fn_body.h" copy_fn_body(s, SIMD_SINGLE_STRIDE, float, BMAS_svec); @@ -147,6 +148,28 @@ one_arg_reduce_fn_body(u32hmin, SIMD_SINGLE_STRIDE, uint32_t, BMAS_ivec, uint3 one_arg_reduce_fn_body(u16hmin, 2*SIMD_SINGLE_STRIDE, uint16_t, BMAS_ivec, uint16_t, uMAX, u16min, u16hmin); one_arg_reduce_fn_body(u8hmin, 4*SIMD_SINGLE_STRIDE, uint8_t, BMAS_ivec, uint8_t, uMAX, u8min, u8hmin); +one_arg_ireduce_fn_body(shimax, SIMD_SINGLE_STRIDE, float, svec, sINDEX, sMIN, sindex, shindex, 'a', sgt); +one_arg_ireduce_fn_body(dhimax, SIMD_DOUBLE_STRIDE, double, dvec, dINDEX, dMIN, dindex, dhindex, 'a', dgt); +one_arg_ireduce_fn_body(i64himax, SIMD_DOUBLE_STRIDE, int64_t, ivec, iINDEX, i64MIN, i64index, i64hindex, 'a', i64gt); +one_arg_ireduce_fn_body(i32himax, SIMD_SINGLE_STRIDE, int32_t, ivec, iINDEX, i32MIN, i32index, i32hindex, 'a', i32gt); +one_arg_ireduce_fn_body(i16himax, 2*SIMD_SINGLE_STRIDE, int16_t, ivec, iINDEX, i16MIN, i16index, i16hindex, 'a', i16gt); +one_arg_ireduce_fn_body(i8himax, 4*SIMD_SINGLE_STRIDE, int8_t, ivec, iINDEX, i8MIN, i8index, i8hindex, 'a', i8gt); +one_arg_ireduce_fn_body(u64himax, SIMD_DOUBLE_STRIDE, uint64_t, ivec, iINDEX, uMIN, u64index, u64hindex, 'a', u64gt); +one_arg_ireduce_fn_body(u32himax, SIMD_SINGLE_STRIDE, uint32_t, ivec, iINDEX, uMIN, u32index, u32hindex, 'a', u32gt); +one_arg_ireduce_fn_body(u16himax, 2*SIMD_SINGLE_STRIDE, uint16_t, ivec, iINDEX, uMIN, u16index, u16hindex, 'a', u16gt); +one_arg_ireduce_fn_body(u8himax, 4*SIMD_SINGLE_STRIDE, uint8_t, ivec, iINDEX, uMIN, u8index, u8hindex, 'a', u8gt); + +one_arg_ireduce_fn_body(shimin, SIMD_SINGLE_STRIDE, float, svec, sINDEX, sMAX, sindex, shindex, 'i', slt); +one_arg_ireduce_fn_body(dhimin, SIMD_DOUBLE_STRIDE, double, dvec, dINDEX, dMAX, dindex, dhindex, 'i', dlt); +one_arg_ireduce_fn_body(i64himin, SIMD_DOUBLE_STRIDE, int64_t, ivec, iINDEX, i64MAX, i64index, i64hindex, 'i', i64lt); +one_arg_ireduce_fn_body(i32himin, SIMD_SINGLE_STRIDE, int32_t, ivec, iINDEX, i32MAX, i32index, i32hindex, 'i', i32lt); +one_arg_ireduce_fn_body(i16himin, 2*SIMD_SINGLE_STRIDE, int16_t, ivec, iINDEX, i16MAX, i16index, i16hindex, 'i', i16lt); +one_arg_ireduce_fn_body(i8himin, 4*SIMD_SINGLE_STRIDE, int8_t, ivec, iINDEX, i8MAX, i8index, i8hindex, 'i', i8lt); +one_arg_ireduce_fn_body(u64himin, SIMD_DOUBLE_STRIDE, uint64_t, ivec, iINDEX, uMAX, u64index, u64hindex, 'i', u64lt); +one_arg_ireduce_fn_body(u32himin, SIMD_SINGLE_STRIDE, uint32_t, ivec, iINDEX, uMAX, u32index, u32hindex, 'i', u32lt); +one_arg_ireduce_fn_body(u16himin, 2*SIMD_SINGLE_STRIDE, uint16_t, ivec, iINDEX, uMAX, u16index, u16hindex, 'i', u16lt); +one_arg_ireduce_fn_body(u8himin, 4*SIMD_SINGLE_STRIDE, uint8_t, ivec, iINDEX, uMAX, u8index, u8hindex, 'i', u8lt); + dot_fn_body(sdot, SIMD_SINGLE_STRIDE, float, BMAS_svec, float, szero, sadd, smul, shadd); dot_fn_body(ddot, SIMD_DOUBLE_STRIDE, double, BMAS_dvec, double, dzero, dadd, dmul, dhadd); diff --git a/bmas/bmas.h b/bmas/bmas.h index c9ae86c..235b370 100644 --- a/bmas/bmas.h +++ b/bmas/bmas.h @@ -353,6 +353,28 @@ one_arg_reduce_fn(u16hmin, uint16_t, uint16_t); one_arg_reduce_fn(u32hmin, uint32_t, uint32_t); one_arg_reduce_fn(u64hmin, uint64_t, uint64_t); +#define one_arg_ireduce_fn(name, itype, otype) long BMAS_##name(const long n, itype* x, const int64_t incx); +one_arg_ireduce_fn(shimax, float, float); +one_arg_ireduce_fn(dhimax, double, double); +one_arg_ireduce_fn(i8himax, int8_t, int8_t); +one_arg_ireduce_fn(i16himax, int16_t, int16_t); +one_arg_ireduce_fn(i32himax, int32_t, int32_t); +one_arg_ireduce_fn(i64himax, int64_t, int64_t); +one_arg_ireduce_fn(u8himax, uint8_t, uint8_t); +one_arg_ireduce_fn(u16himax, uint16_t, uint16_t); +one_arg_ireduce_fn(u32himax, uint32_t, uint32_t); +one_arg_ireduce_fn(u64himax, uint64_t, uint64_t); + +one_arg_ireduce_fn(shimin, float, float); +one_arg_ireduce_fn(dhimin, double, double); +one_arg_ireduce_fn(i8himin, int8_t, int8_t); +one_arg_ireduce_fn(i16himin, int16_t, int16_t); +one_arg_ireduce_fn(i32himin, int32_t, int32_t); +one_arg_ireduce_fn(i64himin, int64_t, int64_t); +one_arg_ireduce_fn(u8himin, uint8_t, uint8_t); +one_arg_ireduce_fn(u16himin, uint16_t, uint16_t); +one_arg_ireduce_fn(u32himin, uint32_t, uint32_t); +one_arg_ireduce_fn(u64himin, uint64_t, uint64_t); #define dot_fn(name, itype, otype) \ otype BMAS_##name(const long n,\ diff --git a/bmas/one_arg_ireduce_fn_body.h b/bmas/one_arg_ireduce_fn_body.h new file mode 100644 index 0000000..225ddc6 --- /dev/null +++ b/bmas/one_arg_ireduce_fn_body.h @@ -0,0 +1,51 @@ + +// The way this is currently implemented, a vector-accumulator, having +// a larger otype wouldn't make a difference; for that, the vector-accumulator and +// store-load instructions themselves would need to be changed. + +// An acc (accumulator) below comprises of struct made of a "value" vector +// and one or more "index" vector(s) + +#define one_arg_ireduce_fn_body( \ + name, _stride, itype, vec, \ + init_index_fn, init_fn, \ + vreduce_fn, hreduce_fn, reduce_fn_char, sreduce_fn) \ + \ + long BMAS_##name(const long n, itype* x, const long incx){ \ + itype* x_end = x + incx * n; \ + BMAS_##vec v; \ + struct BMAS_ipair_##vec acc \ + = BMAS_vector_##init_index_fn(BMAS_vector_##init_fn()); \ + const int stride = _stride; \ + long idx = 0; \ + if (incx == 1){ \ + itype* simd_end = x + (n/stride)*stride; \ + while(x != simd_end){ \ + v = BMAS_##vec##_load(x); \ + acc = BMAS_vector_##vreduce_fn(acc, v, idx, reduce_fn_char); \ + x += stride; \ + idx += stride; \ + } \ + }else{ \ + long i=0; \ + const long simd_end = (n/stride)*stride; \ + while(i != simd_end){ \ + v = BMAS_##vec##_make(x, incx, sizeof(itype)); \ + acc = BMAS_vector_##vreduce_fn(acc, v, idx, reduce_fn_char); \ + i += stride; \ + x += stride * incx; \ + idx += stride; \ + } \ + } \ + struct BMAS_ipair_##itype result \ + = BMAS_vector_##hreduce_fn(acc, reduce_fn_char); \ + while(x!=x_end){ \ + if (BMAS_scalar_##sreduce_fn(x[0], result.value)){ \ + result.idx = idx; \ + result.value = x[0]; \ + } \ + x += incx; \ + idx += 1; \ + } \ + return result.idx; \ + } diff --git a/bmas/scalar.h b/bmas/scalar.h index 398d5ae..41f5011 100644 --- a/bmas/scalar.h +++ b/bmas/scalar.h @@ -1,6 +1,17 @@ #include #include "sleefinline_purec_scalar.h" +struct BMAS_ipair_float{long idx; float value;}; +struct BMAS_ipair_double{long idx; double value;}; +struct BMAS_ipair_int64_t{long idx; int64_t value;}; +struct BMAS_ipair_int32_t{long idx; int32_t value;}; +struct BMAS_ipair_int16_t{long idx; int16_t value;}; +struct BMAS_ipair_int8_t {long idx; int8_t value;}; +struct BMAS_ipair_uint64_t{long idx; uint64_t value;}; +struct BMAS_ipair_uint32_t{long idx; uint32_t value;}; +struct BMAS_ipair_uint16_t{long idx; uint16_t value;}; +struct BMAS_ipair_uint8_t {long idx; uint8_t value;}; + float static inline BMAS_scalar_sadd(float a, float b){return a+b;} float static inline BMAS_scalar_ssub(float a, float b){return a-b;} float static inline BMAS_scalar_smul(float a, float b){return a*b;} diff --git a/bmas/simd/x86_64/avx2.h b/bmas/simd/x86_64/avx2.h index 2c751da..2289fb5 100644 --- a/bmas/simd/x86_64/avx2.h +++ b/bmas/simd/x86_64/avx2.h @@ -8,6 +8,20 @@ typedef __m256d BMAS_dbool; typedef __m256i BMAS_ivec; typedef __m128i BMAS_ivech; +struct BMAS_ipair_svec{ + BMAS_svec value; + BMAS_ivec base_idx_low; + BMAS_ivec base_idx_high; +}; +struct BMAS_ipair_dvec{ + BMAS_dvec value; + BMAS_ivec base_idx; +}; +struct BMAS_ipair_ivec{ + BMAS_ivec value; + BMAS_ivec base_idx[8]; +}; + #define SIMD_SINGLE_STRIDE 8 #define SIMD_DOUBLE_STRIDE 4 @@ -76,14 +90,6 @@ struct BMAS_ipair_ivec static inline BMAS_vector_iINDEX(BMAS_ivec init){ BMAS_svec static inline BMAS_svec_load(float* ptr){ return _mm256_loadu_ps(ptr); } void static inline BMAS_svec_store(float* ptr, BMAS_svec v){ return _mm256_storeu_ps(ptr, v); } -BMAS_cvec static inline BMAS_cvec_load(float complex* ptr){ - float* fptr = (float*)ptr; - return _mm256_loadu_ps(fptr); -} -void static inline BMAS_cvec_store(float complex* ptr, BMAS_svec v){ - float* fptr = (float*)ptr; - return _mm256_storeu_ps(fptr, v); -} BMAS_dvec static inline BMAS_dvec_load(double* ptr){ return _mm256_loadu_pd(ptr); } void static inline BMAS_dvec_store(double* ptr, BMAS_dvec v){ return _mm256_storeu_pd(ptr, v); } @@ -935,6 +941,680 @@ BMAS_ivec static inline BMAS_vector_i32abs(BMAS_ivec a){return _mm256_abs_epi32( BMAS_ivec static inline BMAS_vector_i16abs(BMAS_ivec a){return _mm256_abs_epi16(a);} BMAS_ivec static inline BMAS_vector_i8abs (BMAS_ivec a){return _mm256_abs_epi8(a);} +struct BMAS_ipair_svec static inline BMAS_vector_sindex( + const struct BMAS_ipair_svec old, BMAS_svec new, + const long base_idx, const char max_or_min){ + struct BMAS_ipair_svec res; + if (max_or_min == 'a'){ + res.value = _mm256_max_ps(old.value, new); + }else if (max_or_min == 'i'){ + res.value = _mm256_min_ps(old.value, new); + } + __m256 cmp_res = _mm256_cmp_ps(res.value, new, _CMP_EQ_OQ); + int mask = _mm256_movemask_ps(cmp_res); + if (mask == 0){ + res.base_idx_low = old.base_idx_low; + res.base_idx_high = old.base_idx_high; + }else{ + __m256i cmp256 = (__m256i)cmp_res; + cmp256 = _mm256_permute4x64_epi64(cmp256, 0b11011000); + __m256i cmp256low = _mm256_unpacklo_epi32(cmp256, cmp256); + __m256i cmp256high = _mm256_unpackhi_epi32(cmp256, cmp256); + res.base_idx_low = _mm256_blendv_epi8( + old.base_idx_low, + _mm256_set1_epi64x(base_idx), + cmp256low + ); + res.base_idx_high = _mm256_blendv_epi8( + old.base_idx_high, + _mm256_set1_epi64x(base_idx), + cmp256high + ); + } + return res; +} +struct BMAS_ipair_float static inline BMAS_vector_shindex( + struct BMAS_ipair_svec x, const char max_or_min){ + float fm; + if (max_or_min == 'a') fm = -FLT_MAX; + else if (max_or_min == 'i') fm = FLT_MAX; + long idx = -1; + for(int i=0; i fm) + || (max_or_min == 'i' && x.value[i] < fm)){ + fm = x.value[i]; + switch(i){ + case 0: idx = (long)_mm256_extract_epi64(x.base_idx_low, 0); break; + case 1: idx = (long)_mm256_extract_epi64(x.base_idx_low, 1); break; + case 2: idx = (long)_mm256_extract_epi64(x.base_idx_low, 2); break; + case 3: idx = (long)_mm256_extract_epi64(x.base_idx_low, 3); break; + } + idx += i; + } + } + for(int i=SIMD_DOUBLE_STRIDE; i<2*SIMD_DOUBLE_STRIDE; i++){ + if ((max_or_min == 'a' && x.value[i] > fm) + || (max_or_min == 'i' && x.value[i] < fm)){ + fm = x.value[i]; + switch(i){ + case 4: idx = (long)_mm256_extract_epi64(x.base_idx_high, 0); break; + case 5: idx = (long)_mm256_extract_epi64(x.base_idx_high, 1); break; + case 6: idx = (long)_mm256_extract_epi64(x.base_idx_high, 2); break; + case 7: idx = (long)_mm256_extract_epi64(x.base_idx_high, 3); break; + } + idx += i; + } + } + struct BMAS_ipair_float res = {idx, fm}; + return res; +} +struct BMAS_ipair_dvec static inline BMAS_vector_dindex( + const struct BMAS_ipair_dvec old, BMAS_dvec new, + const long base_idx, const char max_or_min){ + struct BMAS_ipair_dvec res; + if (max_or_min == 'a'){ + res.value = _mm256_max_pd(old.value, new); + }else if (max_or_min == 'i'){ + res.value = _mm256_min_pd(old.value, new); + } + __m256i cmp256 = (__m256i)_mm256_cmp_pd(res.value, new, _CMP_EQ_OQ); + res.base_idx = _mm256_blendv_epi8( + old.base_idx, + _mm256_set1_epi64x(base_idx), + cmp256 + ); + return res; +} +struct BMAS_ipair_double static inline BMAS_vector_dhindex( + const struct BMAS_ipair_dvec x, const char max_or_min){ + double dm; + if (max_or_min == 'a') dm = -DBL_MAX; + else if (max_or_min == 'i') dm = DBL_MAX; + long idx = -1; + for(int i=0; i dm) + || (max_or_min == 'i' && x.value[i] < dm)){ + dm = x.value[i]; + switch(i){ + case 0: idx = _mm256_extract_epi64(x.base_idx, 0); break; + case 1: idx = _mm256_extract_epi64(x.base_idx, 1); break; + case 2: idx = _mm256_extract_epi64(x.base_idx, 2); break; + case 3: idx = _mm256_extract_epi64(x.base_idx, 3); break; + } + idx += i; + } + } + struct BMAS_ipair_double res = {idx, dm}; + return res; +} +struct BMAS_ipair_ivec static inline BMAS_vector_i64index( + const struct BMAS_ipair_ivec old, BMAS_ivec new, + const long base_idx, const char max_or_min){ + struct BMAS_ipair_ivec res; + switch(max_or_min){ + case 'a': res.value = BMAS_vector_i64max(old.value, new); break; + case 'i': res.value = BMAS_vector_i64min(old.value, new); break; + } + __m256i cmp256 = _mm256_cmpeq_epi64(res.value, new); + res.base_idx[0] = _mm256_blendv_epi8( + old.base_idx[0], + _mm256_set1_epi64x(base_idx), + cmp256 + ); + return res; +} +struct BMAS_ipair_int64_t static inline BMAS_vector_i64hindex( + const struct BMAS_ipair_ivec x, const char max_or_min){ + int64_t m; + switch(max_or_min){ + case 'a': m = 1UL << 63; break; + case 'i': m = 0x8fffffff; break; + } + long idx = -1; + for(int i=0; i m) + || (max_or_min == 'i' && x.value[i] < m)){ + m = x.value[i]; + switch(i){ + case 0: idx = _mm256_extract_epi64(x.base_idx[0], 0); break; + case 1: idx = _mm256_extract_epi64(x.base_idx[0], 1); break; + case 2: idx = _mm256_extract_epi64(x.base_idx[0], 2); break; + case 3: idx = _mm256_extract_epi64(x.base_idx[0], 3); break; + } + idx += i; + } + } + struct BMAS_ipair_int64_t res = {idx, m}; + return res; +} +struct BMAS_ipair_ivec static inline BMAS_vector_i32index( + const struct BMAS_ipair_ivec old, BMAS_ivec new, + const long base_idx, const char max_or_min){ + struct BMAS_ipair_ivec res; + switch(max_or_min){ + case 'a': res.value = BMAS_vector_i32max(old.value, new); break; + case 'i': res.value = BMAS_vector_i32min(old.value, new); break; + } + __m256i cmp256 = _mm256_cmpeq_epi32(res.value, new); + int mask = _mm256_movemask_epi8(cmp256); + if (mask == 0){ + res.base_idx[0] = old.base_idx[0]; + res.base_idx[1] = old.base_idx[1]; + }else{ + cmp256 = _mm256_permute4x64_epi64(cmp256, 0b11011000); + __m256i cmp256low = _mm256_unpacklo_epi32(cmp256, cmp256); + __m256i cmp256high = _mm256_unpackhi_epi32(cmp256, cmp256); + res.base_idx[0] = _mm256_blendv_epi8( + old.base_idx[0], + _mm256_set1_epi64x(base_idx), + cmp256low + ); + res.base_idx[1] = _mm256_blendv_epi8( + old.base_idx[1], + _mm256_set1_epi64x(base_idx), + cmp256high + ); + } + return res; +} +struct BMAS_ipair_int32_t static inline BMAS_vector_i32hindex( + const struct BMAS_ipair_ivec x, const char max_or_min){ + int32_t m; + switch(max_or_min){ + case 'a': m = 1UL << 31; break; + case 'i': m = 0x8fff; break; + } + long idx = -1; + + int32_t v; +#define V_EXTRACT32_MAX_AND_SETM(I) \ + v = _mm256_extract_epi32(x.value, I); \ + if (v>m) {m=v; idx=I + _mm256_extract_epi64(x.base_idx[I/4], I%4);} +#define V_EXTRACT32_MIN_AND_SETM(I) \ + v = _mm256_extract_epi32(x.value, I); \ + if (vm) {m=v; idx=I + _mm256_extract_epi64(x.base_idx[I/4], I%4);} +#define V_EXTRACT16_MIN_AND_SETM(I) \ + v = _mm256_extract_epi16(x.value, I); \ + if (vm) {m=v; idx=I + _mm256_extract_epi64(x.base_idx[I/4], I%4);} +#define V_EXTRACT8_MIN_AND_SETM(I) \ + v = _mm256_extract_epi8(x.value, I); \ + if (v m) + || (max_or_min == 'i' && x.value[i] < m)){ + m = x.value[i]; + switch(i){ + case 0: idx = _mm256_extract_epi64(x.base_idx[0], 0); break; + case 1: idx = _mm256_extract_epi64(x.base_idx[0], 1); break; + case 2: idx = _mm256_extract_epi64(x.base_idx[0], 2); break; + case 3: idx = _mm256_extract_epi64(x.base_idx[0], 3); break; + } + idx += i; + } + } + struct BMAS_ipair_uint64_t res = {idx, m}; + return res; +} +struct BMAS_ipair_ivec static inline BMAS_vector_u32index( + const struct BMAS_ipair_ivec old, BMAS_ivec new, + const long base_idx, const char max_or_min){ + struct BMAS_ipair_ivec res; + switch(max_or_min){ + case 'a': res.value = BMAS_vector_u32max(old.value, new); break; + case 'i': res.value = BMAS_vector_u32min(old.value, new); break; + } + __m256i cmp256 = _mm256_cmpeq_epi32(res.value, new); + int mask = _mm256_movemask_epi8(cmp256); + if (mask == 0){ + res.base_idx[0] = old.base_idx[0]; + res.base_idx[1] = old.base_idx[1]; + }else{ + cmp256 = _mm256_permute4x64_epi64(cmp256, 0b11011000); + __m256i cmp256low = _mm256_unpacklo_epi32(cmp256, cmp256); + __m256i cmp256high = _mm256_unpackhi_epi32(cmp256, cmp256); + res.base_idx[0] = _mm256_blendv_epi8( + old.base_idx[0], + _mm256_set1_epi64x(base_idx), + cmp256low + ); + res.base_idx[1] = _mm256_blendv_epi8( + old.base_idx[1], + _mm256_set1_epi64x(base_idx), + cmp256high + ); + } + return res; +} +struct BMAS_ipair_uint32_t static inline BMAS_vector_u32hindex( + const struct BMAS_ipair_ivec x, const char max_or_min){ + uint32_t m; + switch(max_or_min){ + case 'a': m = 0; break; + case 'i': m = 0xffff; break; + } + long idx = -1; + + uint32_t v; +#define V_EXTRACT32_MAX_AND_SETM(I) \ + v = _mm256_extract_epi32(x.value, I); \ + if (v>m) {m=v; idx=I + _mm256_extract_epi64(x.base_idx[I/4], I%4);} +#define V_EXTRACT32_MIN_AND_SETM(I) \ + v = _mm256_extract_epi32(x.value, I); \ + if (vm) {m=v; idx=I + _mm256_extract_epi64(x.base_idx[I/4], I%4);} +#define V_EXTRACT16_MIN_AND_SETM(I) \ + v = _mm256_extract_epi16(x.value, I); \ + if (vm) {m=v; idx=I + _mm256_extract_epi64(x.base_idx[I/4], I%4);} +#define V_EXTRACT8_MIN_AND_SETM(I) \ + v = _mm256_extract_epi8(x.value, I); \ + if (v", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:50:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:61:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:74:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:75:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:77:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:87:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:88:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:90:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:103:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:106:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 6 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 201706 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 27 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 200809 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1024 }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__WORDSIZE32_SIZE_ULONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:7:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:6:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32 }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:16:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__WORDSIZE32_PTRDIFF_LONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:8:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:48:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmpCM21U60Z-tmp.h:67:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:112:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:110:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:111:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:49:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:105:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:106:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:107:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:108:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:109:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:88:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:44:10", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:177:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:188:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:227:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:242:12", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:226:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:189:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:201:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:200:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 } +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 } ] diff --git a/specs/bmas.aarch64-unknown-linux-android.spec b/specs/bmas.aarch64-unknown-linux-android.spec index d430a47..db4caff 100644 --- a/specs/bmas.aarch64-unknown-linux-android.spec +++ b/specs/bmas.aarch64-unknown-linux-android.spec @@ -1,486 +1,106 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:46:44", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:47:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:55:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:56:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:64:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:65:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 1, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:50:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:61:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:74:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:75:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:77:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:87:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:88:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:90:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:103:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:106:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:6:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32 }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:16:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE32_SIZE_ULONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:7:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE32_PTRDIFF_LONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:8:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:44:10", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:177:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:88:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1024 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 201706 }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 6 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 27 }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:48:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:49:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmpSIT3QPKP-tmp.h:105:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:201:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 200809 }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:188:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:105:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:106:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:108:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:107:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:109:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:189:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:110:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:112:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:111:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:227:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:200:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:242:12", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:226:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } } +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 } ] diff --git a/specs/bmas.arm-pc-linux-gnu.spec b/specs/bmas.arm-pc-linux-gnu.spec index 46337a1..b4ae98f 100644 --- a/specs/bmas.arm-pc-linux-gnu.spec +++ b/specs/bmas.arm-pc-linux-gnu.spec @@ -1,486 +1,105 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:46:44", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:47:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:55:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:56:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:64:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:65:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:50:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:61:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:74:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:75:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:77:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:87:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:88:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:90:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:103:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:106:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:16:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE32_PTRDIFF_LONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:8:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE32_SIZE_ULONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:7:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:6:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32 }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 201706 }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 6 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 27 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2 }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:44:10", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1024 }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:88:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 200809 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:177:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:188:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:189:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:200:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:201:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:226:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:227:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:107:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:108:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:242:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:105:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:111:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:106:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:112:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmp73HU0RPK-tmp.h:115:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:109:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:110:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:48:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } } +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 } ] diff --git a/specs/bmas.arm-unknown-linux-androideabi.spec b/specs/bmas.arm-unknown-linux-androideabi.spec index 5a73a7c..58f5739 100644 --- a/specs/bmas.arm-unknown-linux-androideabi.spec +++ b/specs/bmas.arm-unknown-linux-androideabi.spec @@ -1,486 +1,105 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:46:44", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:47:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:55:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:56:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:64:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:65:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:50:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:61:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:74:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:75:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:77:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:87:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:88:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:90:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:103:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:106:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:227:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:226:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:242:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:188:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:189:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:200:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:44:10", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 200809 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:201:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:177:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:107:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:106:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:109:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:108:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:105:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:48:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:112:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:110:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmp8065ESJT-tmp.h:88:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:111:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1024 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:88:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:6:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32 }, -{ "tag": "const", "name": "__WORDSIZE32_PTRDIFF_LONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:8:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:16:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__WORDSIZE32_SIZE_ULONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:7:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 201706 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 6 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 27 }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 } +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 } ] diff --git a/specs/bmas.i386-unknown-freebsd.spec b/specs/bmas.i386-unknown-freebsd.spec index e108673..4ac0c45 100644 --- a/specs/bmas.i386-unknown-freebsd.spec +++ b/specs/bmas.i386-unknown-freebsd.spec @@ -1,486 +1,106 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:46:44", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:47:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:55:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:56:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:64:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:65:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:50:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:61:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:74:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:75:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:77:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:87:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:88:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:90:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:103:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:106:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 201706 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 6 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 200809 }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 27 }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2 }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmpUX5S4ADN-tmp.h:54:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:112:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:111:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:109:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:110:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:108:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:107:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:106:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:105:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:48:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:88:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1024 }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:188:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:189:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:200:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:201:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:226:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:227:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:242:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:6:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32 }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:177:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__WORDSIZE32_SIZE_ULONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:7:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE32_PTRDIFF_LONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:8:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:16:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 } +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 } ] diff --git a/specs/bmas.i386-unknown-openbsd.spec b/specs/bmas.i386-unknown-openbsd.spec index 432d1b3..7ff5aa8 100644 --- a/specs/bmas.i386-unknown-openbsd.spec +++ b/specs/bmas.i386-unknown-openbsd.spec @@ -1,486 +1,106 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:46:44", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:47:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:55:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:56:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:64:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:65:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:50:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:61:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:74:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:75:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:77:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:87:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:88:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:90:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:103:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:106:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:108:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:107:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:111:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:110:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:109:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:106:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:105:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 200809 }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 27 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2 }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 201706 }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 6 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1024 }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmpB2JTL1W9-tmp.h:40:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:112:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:6:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32 }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__WORDSIZE32_SIZE_ULONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:7:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__WORDSIZE32_PTRDIFF_LONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:8:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:16:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:88:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:48:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:201:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:200:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:226:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:227:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:177:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:188:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:189:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:242:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 } +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 } ] diff --git a/specs/bmas.i686-apple-darwin9.spec b/specs/bmas.i686-apple-darwin9.spec index 35e6cdb..dce1b19 100644 --- a/specs/bmas.i686-apple-darwin9.spec +++ b/specs/bmas.i686-apple-darwin9.spec @@ -1,485 +1,106 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:46:44", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:47:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:55:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:56:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:64:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:65:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:50:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:61:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:74:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:75:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:77:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:87:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:88:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:90:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:103:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:106:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:16:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:6:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32 }, -{ "tag": "const", "name": "__WORDSIZE32_SIZE_ULONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:7:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE32_PTRDIFF_LONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:8:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:189:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:188:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:177:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:227:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:226:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:201:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:200:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:242:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 200809 }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:109:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:112:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:48:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:110:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:111:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 27 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2 }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 6 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 201706 }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1024 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:88:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:106:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:105:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:108:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:107:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 } +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 } ] diff --git a/specs/bmas.i686-pc-linux-gnu.spec b/specs/bmas.i686-pc-linux-gnu.spec index 93db5c7..2dc11dd 100644 --- a/specs/bmas.i686-pc-linux-gnu.spec +++ b/specs/bmas.i686-pc-linux-gnu.spec @@ -1,486 +1,106 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:46:44", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:47:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:55:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:56:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:64:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:65:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:50:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:61:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:74:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:75:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:77:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:87:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:88:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:90:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:103:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:106:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE32_PTRDIFF_LONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:8:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE32_SIZE_ULONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:7:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:6:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32 }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:16:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:48:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 200809 }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmp2OWI3Q7U-tmp.h:39:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:107:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:106:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:105:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:111:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:112:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:108:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:109:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:110:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1024 }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:88:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 6 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 201706 }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 27 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:242:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:226:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:227:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:201:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:200:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:188:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:189:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:177:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 } +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 } ] diff --git a/specs/bmas.i686-pc-windows-msvc.spec b/specs/bmas.i686-pc-windows-msvc.spec index d3e1e9f..01a3534 100644 --- a/specs/bmas.i686-pc-windows-msvc.spec +++ b/specs/bmas.i686-pc-windows-msvc.spec @@ -1,350 +1,374 @@ [ -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:96:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:98:25", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:110:25", "type": { "tag": "int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:111:26", "type": { "tag": "uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:112:25", "type": { "tag": "int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:113:26", "type": { "tag": "uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:167:24", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:172:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:184:25", "type": { "tag": "int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:185:26", "type": { "tag": "uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:186:25", "type": { "tag": "int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:187:26", "type": { "tag": "uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:205:24", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:207:25", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:215:25", "type": { "tag": "int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:216:26", "type": { "tag": "uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:217:25", "type": { "tag": "int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:218:26", "type": { "tag": "uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:224:23", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:226:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:232:24", "type": { "tag": "int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:233:25", "type": { "tag": "uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:234:24", "type": { "tag": "int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:235:25", "type": { "tag": "uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:249:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:256:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:262:26", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:263:26", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :8:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :10:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :12:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :14:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :18:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :20:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :22:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :24:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :26:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :28:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :30:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :32:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :36:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :38:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :40:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :42:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :44:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :46:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :48:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :50:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :52:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:96:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:98:25", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:110:25", "type": { "tag": "int64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:111:26", "type": { "tag": "uint64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:112:25", "type": { "tag": "int64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:113:26", "type": { "tag": "uint64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:167:24", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:172:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:184:25", "type": { "tag": "int32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:185:26", "type": { "tag": "uint32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:186:25", "type": { "tag": "int32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:187:26", "type": { "tag": "uint32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:205:24", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, +{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:207:25", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, +{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:215:25", "type": { "tag": "int16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:216:26", "type": { "tag": "uint16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:217:25", "type": { "tag": "int16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:218:26", "type": { "tag": "uint16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:224:23", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:226:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:232:24", "type": { "tag": "int8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:233:25", "type": { "tag": "uint8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:234:24", "type": { "tag": "int8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:235:25", "type": { "tag": "uint8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:249:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:256:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:262:26", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:263:26", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :8:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:32:1 :10:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :12:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :14:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :18:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :20:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :22:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :24:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :26:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :28:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :30:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :32:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :36:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :38:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :40:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :42:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :44:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :46:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :48:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :50:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :52:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:79:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:84:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_csin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:88:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ccos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ctan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:92:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:99:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:103:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:107:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:114:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:115:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:120:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:125:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:130:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:135:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:177:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:182:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:187:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:192:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:197:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:202:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:207:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:212:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:213:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:218:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:223:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:228:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:233:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:238:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:243:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:244:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:249:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:254:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:259:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:264:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:269:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:274:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:279:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:284:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:289:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:290:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:291:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:297:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:299:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "__int_least64_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:99:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__uint_least8_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:228:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__uint_least64_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:100:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__int_least32_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:175:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__uint_least16_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__int_least8_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__uint_least32_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:176:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__int_least16_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:208:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INT_LEAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:602:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "__INT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:603:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "__UINT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:466:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__INT_LEAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:624:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "__INT_LEAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:558:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__UINT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:604:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:479:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__INT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:559:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "__UINT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:626:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "__UINT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:560:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__INT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:625:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:462:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:461:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:463:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__INT_LEAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:464:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__INT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:465:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__int8_c_suffix", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:424:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__int32_c_suffix", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:365:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__int16_c_suffix", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:403:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:622:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:630:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:623:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:616:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:621:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:614:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:615:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:612:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:613:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:635:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:633:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:634:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:631:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:632:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:556:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:557:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:570:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:484:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:555:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:482:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:483:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:480:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:481:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:600:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:611:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:575:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:601:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:599:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:573:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:574:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:571:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:572:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:684:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:678:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:671:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:670:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:648:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:650:9", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:649:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:668:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:664:9", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:667:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:663:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:662:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:653:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:652:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:651:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 } +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:316:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:322:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:323:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:324:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:332:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:343:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, +{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, +{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, +{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, +{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:354:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, +{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:355:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, +{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:356:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, +{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:357:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, +{ "tag": "function", "name": "BMAS_shimax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dhimax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i8himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:362:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i16himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i32himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :266:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i64himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :267:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u8himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :268:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u16himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:367:1 :269:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u32himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:368:1 :270:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u64himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:369:1 :271:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_shimin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:371:1 :272:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dhimin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:372:1 :273:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i8himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:373:1 :274:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i16himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:374:1 :275:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i32himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:375:1 :276:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i64himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:376:1 :277:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u8himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:377:1 :278:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u16himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:378:1 :279:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u32himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:379:1 :280:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u64himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:380:1 :281:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:386:1 :282:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:387:1 :283:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:389:1 :284:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:390:1 :285:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:391:1 :286:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:392:1 :287:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:621:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:622:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:623:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:647:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:648:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:649:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:650:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:651:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:652:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:699:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:700:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:701:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:721:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:722:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:723:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:724:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:463:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "__INT_LEAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:476:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:461:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:462:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "__int8_c_suffix", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:424:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__int16_c_suffix", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:403:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__int32_c_suffix", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:365:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__int64_c_suffix", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:289:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:495:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:494:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:493:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:492:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:496:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:491:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "__UINT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:746:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "__INT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:745:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "__UINT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:705:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "__INT_LEAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:744:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "__INT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:704:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "__INT_LEAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:703:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "__UINT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:627:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "__INT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:626:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "__INT_LEAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:625:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "__UINT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:478:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "__INT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:477:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "__uint_least8_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:228:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__int_least8_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__uint_least16_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__int_least16_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:208:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__uint_least32_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:176:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__int_least32_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:175:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__uint_least64_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:100:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__int_least64_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:99:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:828:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:835:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:841:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:825:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:811:9", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:809:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:810:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:824:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:827:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:788:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:787:9", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:790:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:789:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:785:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:786:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:763:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:759:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:758:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:761:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:762:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:760:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:740:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:725:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:726:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:742:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:741:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 } ] diff --git a/specs/bmas.i686-unknown-linux-android.spec b/specs/bmas.i686-unknown-linux-android.spec index c88f990..ff51b17 100644 --- a/specs/bmas.i686-unknown-linux-android.spec +++ b/specs/bmas.i686-unknown-linux-android.spec @@ -1,486 +1,106 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:46:44", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:47:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:55:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:56:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:64:37", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:65:46", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": "__quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": "__u_quad_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:50:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:61:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:74:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:75:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:77:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:87:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:88:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:90:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:103:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:106:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:105:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:106:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:110:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:111:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:107:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:109:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:108:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:48:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmpJRWHHVG0-tmp.h:54:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:112:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 200809 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 201706 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 6 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 27 }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1024 }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:88:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:16:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE32_PTRDIFF_LONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:8:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__WORDSIZE32_SIZE_ULONG", "ns": 0, "location": "/usr/include/bits/wordsize.h:7:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:6:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32 }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:226:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:227:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:201:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:189:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:188:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:177:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:200:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 1 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:242:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 } +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 32, "bit-alignment": 32 }, "value": 4294967295 } ] diff --git a/specs/bmas.x86_64-apple-darwin9.spec b/specs/bmas.x86_64-apple-darwin9.spec index 27af0f4..cddc3b6 100644 --- a/specs/bmas.x86_64-apple-darwin9.spec +++ b/specs/bmas.x86_64-apple-darwin9.spec @@ -1,486 +1,106 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:43:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:44:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:52:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:53:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:61:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:62:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:47:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:58:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:70:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:71:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:72:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:83:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:84:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:85:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:97:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:100:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:175:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:165:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:197:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:196:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:237:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:220:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__SYSCALL_WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:14:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:12:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:4:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:120:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:45:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1024 }, -{ "tag": "const", "name": "__OFF_T_MATCHES_OFF64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:80:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:86:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__INO_T_MATCHES_INO64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:83:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 201706 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 6 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 27 }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:164:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 200809 }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:185:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:174:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:198:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:186:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:219:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 } +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 } ] diff --git a/specs/bmas.x86_64-pc-linux-gnu.spec b/specs/bmas.x86_64-pc-linux-gnu.spec index 09b2dc5..4e3d42d 100644 --- a/specs/bmas.x86_64-pc-linux-gnu.spec +++ b/specs/bmas.x86_64-pc-linux-gnu.spec @@ -1,58 +1,67 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:43:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:44:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:52:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:53:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:61:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:62:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:133:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:137:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:139:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:141:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:146:28", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:168:30", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:172:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:176:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:179:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:181:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:194:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:31:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:32:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, +{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:33:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:34:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:37:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:38:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:39:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, +{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:40:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, +{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:41:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:42:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:44:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:45:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__int_least8_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:52:18", "type": { "tag": "__int8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "__uint_least8_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:53:19", "type": { "tag": "__uint8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "__int_least16_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:54:19", "type": { "tag": "__int16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "__uint_least16_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:55:20", "type": { "tag": "__uint16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "__int_least32_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:56:19", "type": { "tag": "__int32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "__uint_least32_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:57:20", "type": { "tag": "__uint32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "__int_least64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:58:19", "type": { "tag": "__int64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "__uint_least64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:59:20", "type": { "tag": "__uint64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:63:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:64:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:72:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:73:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:145:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:146:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:147:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:148:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:149:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:150:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:151:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:152:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:153:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:154:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:155:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:155:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, +{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:156:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:157:26", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:158:28", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:159:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:160:26", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:161:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:162:31", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__suseconds64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:163:33", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:165:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:166:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:169:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:172:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, +{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:175:29", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:180:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:181:30", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:184:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:185:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:188:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:189:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:192:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:194:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:197:33", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:199:33", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:203:19", "type": { "tag": "__off64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:204:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, +{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:207:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:210:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/x86_64-linux-gnu/bits/types.h:215:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/x86_64-linux-gnu/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, { "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/x86_64-linux-gnu/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, { "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/x86_64-linux-gnu/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, @@ -61,427 +70,475 @@ { "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/x86_64-linux-gnu/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, { "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/x86_64-linux-gnu/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, { "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/x86_64-linux-gnu/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:47:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:58:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:70:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:71:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:72:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:83:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:84:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:85:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:97:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:100:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:24", "type": { "tag": "__int_least8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:25", "type": { "tag": "__int_least16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:25", "type": { "tag": "__int_least32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:46:25", "type": { "tag": "__int_least64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:49:25", "type": { "tag": "__uint_least8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:50:26", "type": { "tag": "__uint_least16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:51:26", "type": { "tag": "__uint_least32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:52:26", "type": { "tag": "__uint_least64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:60:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:61:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:62:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:73:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:74:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:75:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:87:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:90:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:101:21", "type": { "tag": "__intmax_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:102:22", "type": { "tag": "__uintmax_t" } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :28:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :30:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:32:1 :32:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :36:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :38:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :40:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :42:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :44:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :46:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :48:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :50:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :52:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:79:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:84:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_csin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:88:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ccos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ctan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:92:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:99:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:103:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:107:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:114:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:115:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:120:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:125:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:130:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:135:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:177:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:182:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:187:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:192:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:197:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:202:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:207:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:212:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:213:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:218:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:223:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:228:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:233:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:238:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:243:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:244:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:249:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:254:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:259:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:264:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:269:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:274:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:279:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:284:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:289:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:290:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:291:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:297:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:299:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__SYSCALL_WORDSIZE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wordsize.h:14:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wordsize.h:12:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wordsize.h:4:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:164:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:165:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:175:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:316:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:322:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:323:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:324:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:332:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :266:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :267:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :268:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :269:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:343:1 :270:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, +{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :271:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, +{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :272:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, +{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :273:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, +{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :274:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :275:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :276:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :277:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :278:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :279:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:354:1 :280:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, +{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:355:1 :281:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, +{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:356:1 :282:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, +{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:357:1 :283:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, +{ "tag": "function", "name": "BMAS_shimax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :284:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_dhimax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :285:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:362:1 :286:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i16himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :287:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i32himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :288:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i64himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :289:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_u8himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :290:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_u16himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:367:1 :291:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_u32himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:368:1 :292:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_u64himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:369:1 :293:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_shimin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:371:1 :294:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_dhimin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:372:1 :295:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:373:1 :296:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i16himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:374:1 :297:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i32himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:375:1 :298:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i64himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:376:1 :299:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_u8himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:377:1 :300:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_u16himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:378:1 :301:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_u32himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:379:1 :302:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_u64himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:380:1 :303:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:386:1 :304:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:387:1 :305:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:389:1 :306:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:390:1 :307:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:391:1 :308:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:392:1 :309:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:325:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT_C2X", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/libc-header-start.h:77:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:329:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, { "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:343:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:345:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:250:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/libc-header-start.h:71:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:456:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__TIMESIZE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/timesize.h:26:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, +{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:461:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:495:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wordsize.h:4:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, +{ "tag": "const", "name": "__attribute_artificial__", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:433:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wordsize.h:12:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__SYSCALL_WORDSIZE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wordsize.h:14:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, +{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:455:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:351:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__attribute_warn_unused_result__", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:406:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:424:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__returns_nonnull", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:397:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:285:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:62:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 201706 }, +{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:477:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2 }, +{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:473:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 6 }, +{ "tag": "const", "name": "__attribute_malloc__", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:281:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__attribute_deprecated__", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:339:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:52:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__STDC_IEC_60559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:53:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 201404 }, +{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:330:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__attribute_pure__", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:308:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__attribute_noinline__", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:331:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:42:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__attribute_const__", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:315:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__STDC_IEC_60559_BFP__", "ns": 0, "location": "/usr/include/stdc-predef.h:43:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 201404 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:654:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "__LDOUBLE_REDIRECTS_TO_FLOAT128_ABI", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/long-double.h:21:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "__THROWNL", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:80:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "__THROW", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:79:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "_BITS_TIME64_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/time64.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:103:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1024 }, +{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:333:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "__KERNEL_OLD_TIMEVAL_MATCHES_TIMEVAL64", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:93:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "__STATFS_MATCHES_STATFS64", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:90:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:341:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:337:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__TIME64_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/time64.h:30:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:478:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 35 }, +{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:428:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:186:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:188:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, +{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:175:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, +{ "tag": "const", "name": "__attribute_maybe_unused__", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:321:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_SCANF", "ns": 0, "location": "/usr/include/features.h:459:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:436:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "__SUSECONDS64_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__GLIBC_USE_ISOC2X", "ns": 0, "location": "/usr/include/features.h:244:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:176:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, +{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:349:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:217:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:216:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:165:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:399:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__INO_T_MATCHES_INO64_T", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:84:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:87:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:75:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "__OFF_T_MATCHES_OFF64_T", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:81:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:45:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:236:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, { "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:290:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 200809 }, +{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:128:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:288:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, { "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__OFF_T_MATCHES_OFF64_T", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:80:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__INO_T_MATCHES_INO64_T", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:83:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:130:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:129:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:132:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:133:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:154:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:131:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, { "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:174:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:86:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:120:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1024 }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:185:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmpX4BRKI0R-tmp.h:103:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:187:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:135:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, { "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:109:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:111:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:110:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmpI9WG87JK-tmp.h:162:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:113:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:164:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, { "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:112:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:237:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 200809 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 27 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 6 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 201706 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:219:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:220:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:197:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:196:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:198:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:186:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 } +{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:114:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:227:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:155:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:210:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:209:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/libc-header-start.h:109:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_EXT", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/libc-header-start.h:83:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/libc-header-start.h:94:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT_C2X", "ns": 0, "location": "/usr/include/x86_64-linux-gnu/bits/libc-header-start.h:100:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 } ] diff --git a/specs/bmas.x86_64-pc-windows-msvc.spec b/specs/bmas.x86_64-pc-windows-msvc.spec index ff9968d..53fa2de 100644 --- a/specs/bmas.x86_64-pc-windows-msvc.spec +++ b/specs/bmas.x86_64-pc-windows-msvc.spec @@ -1,350 +1,374 @@ [ -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:96:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:98:25", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:110:25", "type": { "tag": "int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:111:26", "type": { "tag": "uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:112:25", "type": { "tag": "int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:113:26", "type": { "tag": "uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:167:24", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:172:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:184:25", "type": { "tag": "int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:185:26", "type": { "tag": "uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:186:25", "type": { "tag": "int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:187:26", "type": { "tag": "uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:205:24", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:207:25", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:215:25", "type": { "tag": "int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:216:26", "type": { "tag": "uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:217:25", "type": { "tag": "int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:218:26", "type": { "tag": "uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:224:23", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:226:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:232:24", "type": { "tag": "int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:233:25", "type": { "tag": "uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:234:24", "type": { "tag": "int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:235:25", "type": { "tag": "uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:249:25", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:256:26", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:262:26", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:263:26", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :8:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :10:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :12:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :14:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :18:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :20:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :22:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :24:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :26:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :28:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :30:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :32:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :36:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :38:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :40:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :42:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :44:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :46:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :48:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :50:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :52:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:96:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:98:25", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:110:25", "type": { "tag": "int64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:111:26", "type": { "tag": "uint64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:112:25", "type": { "tag": "int64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:113:26", "type": { "tag": "uint64_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:167:24", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:172:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:184:25", "type": { "tag": "int32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:185:26", "type": { "tag": "uint32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:186:25", "type": { "tag": "int32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:187:26", "type": { "tag": "uint32_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:205:24", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, +{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:207:25", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, +{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:215:25", "type": { "tag": "int16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:216:26", "type": { "tag": "uint16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:217:25", "type": { "tag": "int16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:218:26", "type": { "tag": "uint16_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:224:23", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:226:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:232:24", "type": { "tag": "int8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:233:25", "type": { "tag": "uint8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:234:24", "type": { "tag": "int8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:235:25", "type": { "tag": "uint8_t" } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:249:25", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:256:26", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:262:26", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:263:26", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :8:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:32:1 :10:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :12:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :14:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :18:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :20:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :22:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :24:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :26:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :28:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :30:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :32:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :36:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :38:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :40:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :42:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :44:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :46:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :48:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :50:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :52:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:79:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:84:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_csin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:88:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ccos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ctan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:92:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:99:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:103:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:107:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:114:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:115:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:120:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:125:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:130:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:135:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:177:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:182:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:187:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:192:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:197:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:202:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:207:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:212:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:213:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:218:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:223:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:228:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:233:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:238:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:243:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:244:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:249:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:254:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:259:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:264:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:269:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:274:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:279:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:284:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:289:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:290:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:291:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:297:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:299:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:662:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:664:9", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:663:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:668:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:678:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:670:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:671:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:667:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:684:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:649:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:648:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:651:9", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:653:12", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:650:9", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:652:9", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__uint_least64_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:100:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__int_least64_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:99:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__uint_least32_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:176:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__int_least32_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:175:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__uint_least16_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__int_least16_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:208:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__uint_least8_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:228:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__int_least8_t", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__UINT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:560:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__INT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:559:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "__INT_LEAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:558:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "__UINT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:466:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__INT_LEAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:624:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "__UINT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:604:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "__INT_LEAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:602:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:461:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__INT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:465:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "__INT_LEAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:464:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:463:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:462:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "__int16_c_suffix", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:403:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__int32_c_suffix", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:365:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "__INT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:603:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "__int8_c_suffix", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:424:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:632:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:633:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:635:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:634:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:622:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:623:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:630:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:631:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:613:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:614:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:615:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:621:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:616:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:600:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:601:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:611:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:612:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:572:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:573:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:574:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:575:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:599:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:556:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:557:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:570:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:571:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:481:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:482:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:483:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:484:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:555:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, -{ "tag": "const", "name": "__INT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:625:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, -{ "tag": "const", "name": "__UINT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:626:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:479:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-11/lib/clang/11.1.0/include/stdint.h:480:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 } +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:316:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:322:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:323:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:324:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:332:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:343:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, +{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, +{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, +{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, +{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:354:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, +{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:355:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, +{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:356:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, +{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:357:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, +{ "tag": "function", "name": "BMAS_shimax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dhimax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i8himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:362:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i16himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i32himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :266:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i64himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :267:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u8himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :268:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u16himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:367:1 :269:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u32himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:368:1 :270:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u64himax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:369:1 :271:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_shimin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:371:1 :272:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_dhimin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:372:1 :273:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i8himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:373:1 :274:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i16himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:374:1 :275:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i32himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:375:1 :276:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_i64himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:376:1 :277:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u8himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:377:1 :278:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u16himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:378:1 :279:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u32himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:379:1 :280:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_u64himin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:380:1 :281:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:386:1 :282:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:387:1 :283:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:389:1 :284:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, +{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:390:1 :285:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, +{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:391:1 :286:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, +{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:392:1 :287:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, +{ "tag": "const", "name": "__int64_c_suffix", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:289:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__int32_c_suffix", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:365:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__int8_c_suffix", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:424:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__int16_c_suffix", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:403:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:740:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:741:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:742:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:461:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:463:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:758:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:462:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "__INT_LEAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:476:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:759:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:760:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "__INT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:477:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:762:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:761:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "__UINT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:478:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:763:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:726:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:647:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:623:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:622:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:649:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:648:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:651:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:650:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:699:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:652:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:721:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:701:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:700:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:723:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:722:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:725:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:724:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:811:9", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, +{ "tag": "const", "name": "__INT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:626:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "__INT_LEAST32_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:625:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:810:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "__int_least8_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:227:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__uint_least8_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:228:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__INT_LEAST16_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:703:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -32768 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:824:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -2147483648 }, +{ "tag": "const", "name": "__UINT_LEAST32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:627:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:835:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "__UINT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:705:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:827:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:828:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 65535 }, +{ "tag": "const", "name": "__INT_LEAST16_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:704:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 32767 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:825:9", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "__INT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:745:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 127 }, +{ "tag": "const", "name": "__INT_LEAST8_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:744:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -128 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:841:11", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "__int_least64_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:99:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:491:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:785:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "__uint_least64_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:100:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__UINT_LEAST8_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:746:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 255 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:787:9", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:493:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:786:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:492:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "__int_least16_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:208:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:495:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:790:12", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, +{ "tag": "const", "name": "__uint_least16_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:788:9", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:494:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 0 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:789:9", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "__int_least32_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:175:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:621:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": 2147483647 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:809:10", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:496:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 }, "value": -1 }, +{ "tag": "const", "name": "__uint_least32_t", "ns": 0, "location": "/usr/lib/llvm-15/lib/clang/15.0.7/include/stdint.h:176:10", "type": { "tag": ":long", "bit-size": 32, "bit-alignment": 32 } } ] diff --git a/specs/bmas.x86_64-unknown-freebsd.spec b/specs/bmas.x86_64-unknown-freebsd.spec index 504b9d6..af3e440 100644 --- a/specs/bmas.x86_64-unknown-freebsd.spec +++ b/specs/bmas.x86_64-unknown-freebsd.spec @@ -1,487 +1,106 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:43:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:44:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:52:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:53:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:61:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:62:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:47:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:58:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:70:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:71:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:72:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:83:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:84:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:85:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:97:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:100:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:219:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:220:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:197:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:198:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:196:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__OFF_T_MATCHES_OFF64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:80:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:237:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:4:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:12:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__SYSCALL_WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:14:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 200809 }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 6 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 201706 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 27 }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:45:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:120:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmpZ7CBRM0G-tmp.h:83:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:164:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:165:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:174:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__INO_T_MATCHES_INO64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:83:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:86:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:175:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:185:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1024 }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:186:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } } +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 } ] diff --git a/specs/bmas.x86_64-unknown-linux-android.spec b/specs/bmas.x86_64-unknown-linux-android.spec index 7706f13..ac8e855 100644 --- a/specs/bmas.x86_64-unknown-linux-android.spec +++ b/specs/bmas.x86_64-unknown-linux-android.spec @@ -1,487 +1,106 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:43:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:44:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:52:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:53:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:61:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:62:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:47:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:58:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:70:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:71:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:72:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:83:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:84:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:85:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:97:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:100:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:120:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__SYSCALL_WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:14:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:12:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:174:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 201706 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:175:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:165:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:164:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:198:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:197:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:196:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:4:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:185:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:186:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:237:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:219:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:220:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__OFF_T_MATCHES_OFF64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:80:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__INO_T_MATCHES_INO64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:83:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1024 }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:86:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmpA0I3UKX8-tmp.h:91:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:45:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 200809 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 27 }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 6 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 } +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 } ] diff --git a/specs/bmas.x86_64-unknown-openbsd.spec b/specs/bmas.x86_64-unknown-openbsd.spec index 7012c65..964ab26 100644 --- a/specs/bmas.x86_64-unknown-openbsd.spec +++ b/specs/bmas.x86_64-unknown-openbsd.spec @@ -1,487 +1,106 @@ [ -{ "tag": "typedef", "ns": 0, "name": "__u_char", "location": "/usr/include/bits/types.h:30:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_short", "location": "/usr/include/bits/types.h:31:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_int", "location": "/usr/include/bits/types.h:32:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_long", "location": "/usr/include/bits/types.h:33:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__int8_t", "location": "/usr/include/bits/types.h:36:21", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint8_t", "location": "/usr/include/bits/types.h:37:23", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "__int16_t", "location": "/usr/include/bits/types.h:38:26", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint16_t", "location": "/usr/include/bits/types.h:39:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "__int32_t", "location": "/usr/include/bits/types.h:40:20", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint32_t", "location": "/usr/include/bits/types.h:41:22", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__int64_t", "location": "/usr/include/bits/types.h:43:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uint64_t", "location": "/usr/include/bits/types.h:44:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__quad_t", "location": "/usr/include/bits/types.h:52:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__u_quad_t", "location": "/usr/include/bits/types.h:53:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__intmax_t", "location": "/usr/include/bits/types.h:61:18", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uintmax_t", "location": "/usr/include/bits/types.h:62:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__dev_t", "location": "/usr/include/bits/types.h:133:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__uid_t", "location": "/usr/include/bits/types.h:134:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__gid_t", "location": "/usr/include/bits/types.h:135:25", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino_t", "location": "/usr/include/bits/types.h:136:25", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ino64_t", "location": "/usr/include/bits/types.h:137:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__mode_t", "location": "/usr/include/bits/types.h:138:26", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__nlink_t", "location": "/usr/include/bits/types.h:139:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off_t", "location": "/usr/include/bits/types.h:140:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__off64_t", "location": "/usr/include/bits/types.h:141:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__pid_t", "location": "/usr/include/bits/types.h:142:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsid_t", "location": "/usr/include/bits/types.h:143:26", "type": { "tag": "struct", "ns": 0, "name": "", "id": 1, "location": "/usr/include/bits/types.h:143:12 ", "bit-size": 64, "bit-alignment": 32, "fields": [{ "tag": "field", "name": "__val", "bit-offset": 0, "bit-size": 64, "bit-alignment": 32, "type": { "tag": ":array", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 }, "size": 2 } }] } }, -{ "tag": "typedef", "ns": 0, "name": "__clock_t", "location": "/usr/include/bits/types.h:144:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim_t", "location": "/usr/include/bits/types.h:145:26", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__rlim64_t", "location": "/usr/include/bits/types.h:146:28", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__id_t", "location": "/usr/include/bits/types.h:147:24", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__time_t", "location": "/usr/include/bits/types.h:148:26", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__useconds_t", "location": "/usr/include/bits/types.h:149:30", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__suseconds_t", "location": "/usr/include/bits/types.h:150:31", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__daddr_t", "location": "/usr/include/bits/types.h:152:27", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__key_t", "location": "/usr/include/bits/types.h:153:25", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__clockid_t", "location": "/usr/include/bits/types.h:156:29", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__timer_t", "location": "/usr/include/bits/types.h:159:27", "type": { "tag": ":pointer", "type": { "tag": ":void" } } }, -{ "tag": "typedef", "ns": 0, "name": "__blksize_t", "location": "/usr/include/bits/types.h:162:29", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt_t", "location": "/usr/include/bits/types.h:167:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__blkcnt64_t", "location": "/usr/include/bits/types.h:168:30", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt_t", "location": "/usr/include/bits/types.h:171:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsblkcnt64_t", "location": "/usr/include/bits/types.h:172:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt_t", "location": "/usr/include/bits/types.h:175:30", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsfilcnt64_t", "location": "/usr/include/bits/types.h:176:32", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__fsword_t", "location": "/usr/include/bits/types.h:179:28", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__ssize_t", "location": "/usr/include/bits/types.h:181:27", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_slong_t", "location": "/usr/include/bits/types.h:184:33", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__syscall_ulong_t", "location": "/usr/include/bits/types.h:186:33", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__loff_t", "location": "/usr/include/bits/types.h:190:19", "type": { "tag": "__off64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "__caddr_t", "location": "/usr/include/bits/types.h:191:15", "type": { "tag": ":pointer", "type": { "tag": ":char", "bit-size": 8, "bit-alignment": 8 } } }, -{ "tag": "typedef", "ns": 0, "name": "__intptr_t", "location": "/usr/include/bits/types.h:194:25", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "__socklen_t", "location": "/usr/include/bits/types.h:197:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "__sig_atomic_t", "location": "/usr/include/bits/types.h:202:13", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int8_t", "location": "/usr/include/bits/stdint-intn.h:24:18", "type": { "tag": "__int8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int16_t", "location": "/usr/include/bits/stdint-intn.h:25:19", "type": { "tag": "__int16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int32_t", "location": "/usr/include/bits/stdint-intn.h:26:19", "type": { "tag": "__int32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int64_t", "location": "/usr/include/bits/stdint-intn.h:27:19", "type": { "tag": "__int64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint8_t", "location": "/usr/include/bits/stdint-uintn.h:24:19", "type": { "tag": "__uint8_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint16_t", "location": "/usr/include/bits/stdint-uintn.h:25:20", "type": { "tag": "__uint16_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint32_t", "location": "/usr/include/bits/stdint-uintn.h:26:20", "type": { "tag": "__uint32_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uint64_t", "location": "/usr/include/bits/stdint-uintn.h:27:20", "type": { "tag": "__uint64_t" } }, -{ "tag": "typedef", "ns": 0, "name": "int_least8_t", "location": "/usr/include/stdint.h:43:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least16_t", "location": "/usr/include/stdint.h:44:20", "type": { "tag": ":short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least32_t", "location": "/usr/include/stdint.h:45:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "int_least64_t", "location": "/usr/include/stdint.h:47:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least8_t", "location": "/usr/include/stdint.h:54:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least16_t", "location": "/usr/include/stdint.h:55:28", "type": { "tag": ":unsigned-short", "bit-size": 16, "bit-alignment": 16 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least32_t", "location": "/usr/include/stdint.h:56:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_least64_t", "location": "/usr/include/stdint.h:58:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:68:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:70:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:71:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:72:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:81:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:83:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:84:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:85:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:97:19", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:100:27", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "typedef", "ns": 0, "name": "intmax_t", "location": "/usr/include/stdint.h:111:21", "type": { "tag": "__intmax_t" } }, -{ "tag": "typedef", "ns": 0, "name": "uintmax_t", "location": "/usr/include/stdint.h:112:22", "type": { "tag": "__uintmax_t" } }, -{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :7:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:31:1 :9:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:33:1 :11:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:34:1 :13:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:35:1 :15:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64copy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:36:1 :17:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:48:1 :19:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:49:1 :21:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:50:1 :23:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:51:1 :25:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:52:1 :27:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:53:1 :29:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:54:1 :31:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:55:1 :33:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64s", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:56:1 :35:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:58:1 :37:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:59:1 :39:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:60:1 :41:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:61:1 :43:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_i64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:62:1 :45:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u8d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:63:1 :47:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u16d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:64:1 :49:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u32d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:65:1 :51:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_cast_u64d", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:66:1 :53:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:80:1 :54:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:81:1 :55:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:82:1 :56:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64abs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:83:1 :57:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:85:1 :58:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:86:1 :59:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:87:1 :60:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:89:1 :61:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:90:1 :62:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:91:1 :63:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:93:1 :64:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_scosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:94:1 :65:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_stanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:95:1 :66:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:96:1 :67:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:97:1 :68:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:98:1 :69:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:100:1 :70:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:101:1 :71:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:102:1 :72:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:104:1 :73:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacos", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:105:1 :74:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:106:1 :75:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:108:1 :76:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dcosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:109:1 :77:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:110:1 :78:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dasinh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:111:1 :79:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dacosh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:112:1 :80:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datanh", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:113:1 :81:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:116:1 :82:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:117:1 :83:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:118:1 :84:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:119:1 :85:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:121:1 :86:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:122:1 :87:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:123:1 :88:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:124:1 :89:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:126:1 :90:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:127:1 :91:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:128:1 :92:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlog1p", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:129:1 :93:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:131:1 :94:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:132:1 :95:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexp10", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:133:1 :96:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dexpm1", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:134:1 :97:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:136:1 :98:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsqrt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:137:1 :99:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:139:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:140:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:141:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:142:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:151:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:160:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:167:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :128:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:174:1 :129:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:175:1 :130:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8add", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:176:1 :131:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:178:1 :132:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:179:1 :133:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:180:1 :134:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:181:1 :135:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:183:1 :136:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:184:1 :137:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:185:1 :138:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:186:1 :139:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:188:1 :140:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:189:1 :141:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:190:1 :142:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8mul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:191:1 :143:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:193:1 :144:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:194:1 :145:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:195:1 :146:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:196:1 :147:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:198:1 :148:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:199:1 :149:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:200:1 :150:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8min", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:201:1 :151:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:203:1 :152:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:204:1 :153:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:205:1 :154:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:206:1 :155:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:208:1 :156:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:209:1 :157:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:210:1 :158:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8max", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:211:1 :159:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:214:1 :160:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:215:1 :161:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:216:1 :162:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:217:1 :163:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:219:1 :164:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:220:1 :165:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:221:1 :166:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:222:1 :167:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:224:1 :168:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:225:1 :169:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:226:1 :170:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:227:1 :171:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:229:1 :172:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:230:1 :173:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:231:1 :174:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:232:1 :175:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:234:1 :176:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:235:1 :177:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:236:1 :178:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:237:1 :179:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:239:1 :180:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:240:1 :181:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:241:1 :182:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:242:1 :183:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:245:1 :184:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:246:1 :185:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:247:1 :186:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8lt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:248:1 :187:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:250:1 :188:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:251:1 :189:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:252:1 :190:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8le", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:253:1 :191:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:255:1 :192:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:256:1 :193:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:257:1 :194:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8eq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:258:1 :195:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:260:1 :196:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:261:1 :197:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:262:1 :198:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8neq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:263:1 :199:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:265:1 :200:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:266:1 :201:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:267:1 :202:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8gt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:268:1 :203:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:270:1 :204:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:271:1 :205:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:272:1 :206:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8ge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:273:1 :207:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i64sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:275:1 :208:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i32sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:276:1 :209:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i16sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:277:1 :210:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8sra", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:278:1 :211:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:280:1 :212:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:281:1 :213:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:282:1 :214:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8srl", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:283:1 :215:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u64sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:285:1 :216:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u32sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:286:1 :217:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u16sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:287:1 :218:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_u8sll", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:288:1 :219:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8not", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:292:6", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "N", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_x", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8and", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:293:1 :220:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8or", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:294:1 :221:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8xor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:295:1 :222:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_i8andnot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:296:1 :223:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:298:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:300:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:301:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast8_t", "location": "/usr/include/stdint.h:58:22", "type": { "tag": ":signed-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast16_t", "location": "/usr/include/stdint.h:64:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast32_t", "location": "/usr/include/stdint.h:65:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "int_fast64_t", "location": "/usr/include/stdint.h:67:24", "type": { "tag": ":long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast8_t", "location": "/usr/include/stdint.h:71:24", "type": { "tag": ":unsigned-char", "bit-size": 8, "bit-alignment": 8 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast16_t", "location": "/usr/include/stdint.h:77:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast32_t", "location": "/usr/include/stdint.h:78:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uint_fast64_t", "location": "/usr/include/stdint.h:80:32", "type": { "tag": ":unsigned-long-long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "typedef", "ns": 0, "name": "intptr_t", "location": "/usr/include/stdint.h:93:15", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "typedef", "ns": 0, "name": "uintptr_t", "location": "/usr/include/stdint.h:96:23", "type": { "tag": ":unsigned-int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "function", "name": "BMAS_scopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:29:1 :4:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dcopy", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:30:1 :6:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_ds", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:47:1 :16:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_cast_sd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:57:1 :34:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_spow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:143:1 :100:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_satan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:144:1 :101:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:145:1 :102:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ssub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:146:1 :103:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:147:1 :104:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sdiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:148:1 :105:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:149:1 :106:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_smax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:150:1 :107:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dpow", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:152:1 :108:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_datan2", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:153:1 :109:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dadd", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:154:1 :110:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dsub", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:155:1 :111:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmul", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:156:1 :112:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_ddiv", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:157:1 :113:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:158:1 :114:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:159:1 :115:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_slt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:161:1 :116:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:162:1 :117:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_seq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:163:1 :118:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:164:1 :119:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:165:1 :120:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_sge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:166:1 :121:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dlt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:168:1 :122:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dle", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:169:1 :123:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_deq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:170:1 :124:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dneq", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:171:1 :125:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dgt", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:172:1 :126:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, +{ "tag": "function", "name": "BMAS_dge", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:173:1 :127:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":_Bool", "bit-size": 8, "bit-alignment": 8 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }], "return-type": { "tag": ":void" } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:302:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:303:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:304:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:305:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:306:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:307:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, { "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:309:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_strunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1 :224:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:312:1 :225:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1 :226:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:314:1 :227:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_sfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:315:1 :228:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dtrunc", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:317:1 :229:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfloor", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:318:1 :230:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dceil", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:319:1 :231:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dround", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:320:1 :232:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_dfabs", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:321:1 :233:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "out", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "inc_out", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":void" } }, -{ "tag": "function", "name": "BMAS_ssum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:325:1 :234:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dsum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:326:1 :235:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:328:1 :236:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:329:1 :237:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:330:1 :238:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64sum", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:331:1 :239:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_shmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:333:1 :240:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:334:1 :241:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:335:1 :242:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:336:1 :243:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:337:1 :244:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:338:1 :245:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:339:1 :246:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:340:1 :247:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:341:1 :248:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmax", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:342:1 :249:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_shmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:344:1 :250:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_dhmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:345:1 :251:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:346:1 :252:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:347:1 :253:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:348:1 :254:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:349:1 :255:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "function", "name": "BMAS_u8hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:350:1 :256:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint8_t" } }, -{ "tag": "function", "name": "BMAS_u16hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:351:1 :257:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint16_t" } }, -{ "tag": "function", "name": "BMAS_u32hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:352:1 :258:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint32_t" } }, -{ "tag": "function", "name": "BMAS_u64hmin", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:353:1 :259:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "uint64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }], "return-type": { "tag": "uint64_t" } }, -{ "tag": "function", "name": "BMAS_sdot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:360:1 :260:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":float", "bit-size": 32, "bit-alignment": 32 } }, -{ "tag": "function", "name": "BMAS_ddot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:361:1 :261:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": ":double", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "function", "name": "BMAS_i8dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:363:1 :262:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int8_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int8_t" } }, -{ "tag": "function", "name": "BMAS_i16dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:364:1 :263:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int16_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int16_t" } }, -{ "tag": "function", "name": "BMAS_i32dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:365:1 :264:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int32_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int32_t" } }, -{ "tag": "function", "name": "BMAS_i64dot", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:366:1 :265:1>", "variadic": false, "inline": false, "storage-class": "none", "parameters": [{ "tag": "parameter", "name": "n", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, { "tag": "parameter", "name": "x", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incx", "type": { "tag": "int64_t" } }, { "tag": "parameter", "name": "y", "type": { "tag": ":pointer", "type": { "tag": "int64_t" } } }, { "tag": "parameter", "name": "incy", "type": { "tag": "int64_t" } }], "return-type": { "tag": "int64_t" } }, -{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:158:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:212:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:209:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:164:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:220:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:165:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:219:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:172:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:232:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:174:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:175:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:233:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:180:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:249:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:183:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "_DEFAULT_SOURCE", "ns": 0, "location": "/usr/include/features.h:221:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:250:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:186:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:185:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:196:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:237:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "_POSIX_SOURCE", "ns": 0, "location": "/usr/include/features.h:263:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_POSIX_C_SOURCE", "ns": 0, "location": "/usr/include/features.h:265:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 200809 }, -{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:198:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 18446744073709551615 }, -{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:197:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:207:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "__USE_POSIX_IMPLICITLY", "ns": 0, "location": "/usr/include/features.h:260:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_ATFILE_SOURCE", "ns": 0, "location": "/usr/include/features.h:326:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_IEC_559__", "ns": 0, "location": "/usr/include/stdc-predef.h:41:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:255:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:254:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "_STDC_PREDEF_H", "ns": 0, "location": "/usr/include/stdc-predef.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_NO_THREADS__", "ns": 0, "location": "/usr/include/stdc-predef.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__STDC_ISO_10646__", "ns": 0, "location": "/usr/include/stdc-predef.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 201706 }, -{ "tag": "const", "name": "__STDC_IEC_559_COMPLEX__", "ns": 0, "location": "/usr/include/stdc-predef.h:49:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC99", "ns": 0, "location": "/usr/include/features.h:320:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC95", "ns": 0, "location": "/usr/include/features.h:318:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ISOC11", "ns": 0, "location": "/usr/include/features.h:227:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX2", "ns": 0, "location": "/usr/include/features.h:304:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199309", "ns": 0, "location": "/usr/include/features.h:308:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX", "ns": 0, "location": "/usr/include/features.h:300:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K", "ns": 0, "location": "/usr/include/features.h:316:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_POSIX199506", "ns": 0, "location": "/usr/include/features.h:312:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_XOPEN2K8", "ns": 0, "location": "/usr/include/features.h:324:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_MISC", "ns": 0, "location": "/usr/include/features.h:368:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__USE_ATFILE", "ns": 0, "location": "/usr/include/features.h:372:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_DEPRECATED_GETS", "ns": 0, "location": "/usr/include/features.h:395:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__UWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:120:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__USE_FORTIFY_LEVEL", "ns": 0, "location": "/usr/include/features.h:387:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__SYSCALL_WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:14:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, -{ "tag": "const", "name": "__UQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__WORDSIZE_TIME64_COMPAT32", "ns": 0, "location": "/usr/include/bits/wordsize.h:12:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__SLONG32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__WORDSIZE", "ns": 0, "location": "/usr/include/bits/wordsize.h:4:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 64 }, -{ "tag": "const", "name": "__SQUAD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:101:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__ULONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:103:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:98:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SLONGWORD_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:102:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__S32_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:100:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U16_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:99:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:317:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__extern_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:345:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__fortify_function", "ns": 0, "location": "/usr/include/sys/cdefs.h:351:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__extern_always_inline", "ns": 0, "location": "/usr/include/sys/cdefs.h:346:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__restrict_arr", "ns": 0, "location": "/usr/include/sys/cdefs.h:384:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_FUNCS_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:60:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__GLIBC_USE_LIB_EXT2", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:42:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "_SYS_CDEFS_H", "ns": 0, "location": "/usr/include/sys/cdefs.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GNU_LIBRARY__", "ns": 0, "location": "/usr/include/features.h:411:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 6 }, -{ "tag": "const", "name": "__GLIBC__", "ns": 0, "location": "/usr/include/features.h:415:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2 }, -{ "tag": "const", "name": "__GLIBC_MINOR__", "ns": 0, "location": "/usr/include/features.h:416:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 27 }, -{ "tag": "const", "name": "__attribute_used__", "ns": 0, "location": "/usr/include/sys/cdefs.h:240:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_BFP_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:51:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__ptr_t", "ns": 0, "location": "/usr/include/sys/cdefs.h:104:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__HAVE_GENERIC_SELECTION", "ns": 0, "location": "/usr/include/sys/cdefs.h:487:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__GLIBC_USE_IEC_60559_TYPES_EXT", "ns": 0, "location": "/usr/include/bits/libc-header-start.h:69:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, -{ "tag": "const", "name": "__glibc_c99_flexarr_available", "ns": 0, "location": "/usr/include/sys/cdefs.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__flexarr", "ns": 0, "location": "/usr/include/sys/cdefs.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__INO_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:41:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "__MODE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:43:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_TYPES_H", "ns": 0, "location": "/usr/include/bits/types.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__INO64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:42:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:132:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "__ID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:62:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:150:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, -{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:131:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:138:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "__GID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:40:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__CLOCK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:63:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__TIME_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:64:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__USECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:65:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, -{ "tag": "const", "name": "__FSBLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:58:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:144:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "__FSBLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:59:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSFILCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:60:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:126:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, -{ "tag": "const", "name": "__FSFILCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:61:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__PID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:53:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:54:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:55:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:133:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "__BLKCNT_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:56:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__BLKCNT64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:57:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:156:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, -{ "tag": "const", "name": "__NLINK_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:45:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:149:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, -{ "tag": "const", "name": "__FSWORD_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, -{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__OFF_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:51:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__OFF64_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:52:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "__FD_SETSIZE", "ns": 0, "location": "/usr/include/bits/typesizes.h:92:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1024 }, -{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, -{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, -{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:151:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "__OFF_T_MATCHES_OFF64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:80:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:155:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, -{ "tag": "const", "name": "__CPU_MASK_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:74:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__RLIM_T_MATCHES_RLIM64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:86:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:157:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, -{ "tag": "const", "name": "__INO_T_MATCHES_INO64_T", "ns": 0, "location": "/usr/include/bits/typesizes.h:83:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__BLKSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:71:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SSIZE_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:73:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_FEATURES_H", "ns": 0, "location": "/usr/include/features.h:19:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__DADDR_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:67:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:310:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:311:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "one_arg_fn", "ns": 0, "location": "/home/shubhamkar/quicklisp/local-projects/cl-bmas/bmas/bmas.h:313:1", "type": { "tag": ":int", "bit-size": 32, "bit-alignment": 32 } }, +{ "tag": "const", "name": "SIZE_MAX", "ns": 0, "location": "/usr/include/stdint.h:232:12", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "SIG_ATOMIC_MAX", "ns": 0, "location": "/usr/include/stdint.h:223:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "WCHAR_MIN", "ns": 0, "location": "/usr/include/stdint.h:239:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "SIG_ATOMIC_MIN", "ns": 0, "location": "/usr/include/stdint.h:222:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "PTRDIFF_MAX", "ns": 0, "location": "/usr/include/stdint.h:217:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "WCHAR_MAX", "ns": 0, "location": "/usr/include/stdint.h:240:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, +{ "tag": "const", "name": "WINT_MAX", "ns": 0, "location": "/usr/include/stdint.h:245:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "WINT_MIN", "ns": 0, "location": "/usr/include/stdint.h:244:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 0 }, +{ "tag": "const", "name": "__GCC_HAVE_DWARF2_CFI_ASM", "ns": 0, "location": ":1:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, { "tag": "const", "name": "_STDINT_H", "ns": 0, "location": "/usr/include/stdint.h:23:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__SUSECONDS_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:66:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__CLOCKID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:69:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__KEY_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:68:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__FSID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:72:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__TIMER_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:70:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_STDINT_INTN_H", "ns": 0, "location": "/usr/include/bits/stdint-intn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__WCHAR_MIN", "ns": 0, "location": "/usr/include/bits/wchar.h:46:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, -{ "tag": "const", "name": "__WCHAR_MAX", "ns": 0, "location": "/usr/include/bits/wchar.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, -{ "tag": "const", "name": "_BITS_STDINT_UINTN_H", "ns": 0, "location": "/usr/include/bits/stdint-uintn.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "_BITS_WCHAR_H", "ns": 0, "location": "/usr/include/bits/wchar.h:20:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__DEV_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:38:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__UID_T_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:39:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SYSCALL_SLONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:34:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__SYSCALL_ULONG_TYPE", "ns": 0, "location": "/usr/include/bits/typesizes.h:35:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__STD_TYPE", "ns": 0, "location": "/tmp/tmpQDARA81Z-tmp.h:154:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "_BITS_TYPESIZES_H", "ns": 0, "location": "/usr/include/bits/typesizes.h:24:9", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 1 }, -{ "tag": "const", "name": "__S64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } }, -{ "tag": "const", "name": "__U64_TYPE", "ns": 0, "location": "/usr/include/bits/types.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 } } +{ "tag": "const", "name": "INT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:123:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:122:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT64_MIN", "ns": 0, "location": "/usr/include/stdint.h:119:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:121:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT32_MIN", "ns": 0, "location": "/usr/include/stdint.h:118:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT16_MIN", "ns": 0, "location": "/usr/include/stdint.h:117:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT8_MIN", "ns": 0, "location": "/usr/include/stdint.h:116:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "PTRDIFF_MIN", "ns": 0, "location": "/usr/include/stdint.h:216:12", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:124:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT8_MAX", "ns": 0, "location": "/usr/include/stdint.h:127:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "UINT16_MAX", "ns": 0, "location": "/usr/include/stdint.h:128:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "UINT32_MAX", "ns": 0, "location": "/usr/include/stdint.h:129:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT64_MAX", "ns": 0, "location": "/usr/include/stdint.h:130:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INT_LEAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:134:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT_LEAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:135:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -32768 }, +{ "tag": "const", "name": "INT_LEAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:136:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_LEAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:137:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:140:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 32767 }, +{ "tag": "const", "name": "INT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:139:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:141:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:142:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINT_LEAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:145:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "UINT_LEAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:146:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 65535 }, +{ "tag": "const", "name": "UINT_LEAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:148:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "UINT_LEAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:147:10", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INT_FAST8_MIN", "ns": 0, "location": "/usr/include/stdint.h:152:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -128 }, +{ "tag": "const", "name": "INT_FAST16_MIN", "ns": 0, "location": "/usr/include/stdint.h:157:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST32_MIN", "ns": 0, "location": "/usr/include/stdint.h:158:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INT_FAST64_MIN", "ns": 0, "location": "/usr/include/stdint.h:160:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:162:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 127 }, +{ "tag": "const", "name": "INT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:167:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "INT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:170:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "INT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:168:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINT_FAST8_MAX", "ns": 0, "location": "/usr/include/stdint.h:173:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 255 }, +{ "tag": "const", "name": "UINT_FAST16_MAX", "ns": 0, "location": "/usr/include/stdint.h:178:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST32_MAX", "ns": 0, "location": "/usr/include/stdint.h:179:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "UINT_FAST64_MAX", "ns": 0, "location": "/usr/include/stdint.h:181:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 }, +{ "tag": "const", "name": "INTPTR_MIN", "ns": 0, "location": "/usr/include/stdint.h:190:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -2147483648 }, +{ "tag": "const", "name": "INTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:191:11", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 2147483647 }, +{ "tag": "const", "name": "UINTPTR_MAX", "ns": 0, "location": "/usr/include/stdint.h:192:11", "type": { "tag": ":unsigned-long", "bit-size": 64, "bit-alignment": 64 }, "value": 4294967295 }, +{ "tag": "const", "name": "INTMAX_MIN", "ns": 0, "location": "/usr/include/stdint.h:197:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -9223372036854775808 }, +{ "tag": "const", "name": "INTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:199:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": 9223372036854775807 }, +{ "tag": "const", "name": "UINTMAX_MAX", "ns": 0, "location": "/usr/include/stdint.h:202:10", "type": { "tag": ":long", "bit-size": 64, "bit-alignment": 64 }, "value": -1 } ]