/** * Compute the Miller loop for pairings of type G_2 x G_1 over the bits of a * given parameter. * * @param[out] r - the result. * @param[out] t - the resulting point. * @param[in] q - the first pairing argument in affine coordinates. * @param[in] p - the second pairing argument in affine coordinates. * @param[in] n - the number of pairings to evaluate. * @param[in] a - the loop parameter. */ static void pp_mil_k12(fp12_t r, ep2_t *t, ep2_t *q, ep_t *p, int m, bn_t a) { fp12_t l; ep_t _p[m]; int i, j; if (m == 0) { return; } fp12_null(l); TRY { fp12_new(l); for (j = 0; j < m; j++) { ep_null(_p[j]); ep_new(_p[j]); #if EP_ADD == BASIC ep_neg(_p[j], p[i]); #else fp_add(_p[j]->x, p[j]->x, p[j]->x); fp_add(_p[j]->x, _p[j]->x, p[j]->x); fp_neg(_p[j]->y, p[j]->y); #endif ep2_copy(t[j], q[j]); } fp12_zero(l); /* Precomputing. */ pp_dbl_k12(r, t[0], t[0], _p[0]); if (bn_get_bit(a, bn_bits(a) - 2)) { for (j = 0; j < m; j++) { pp_add_k12(l, t[j], q[j], p[j]); fp12_mul_dxs(r, r, l); } } for (i = bn_bits(a) - 3; i >= 0; i--) { fp12_sqr(r, r); for (j = 0; j < m; j++) { pp_dbl_k12(l, t[j], t[j], _p[j]); fp12_mul_dxs(r, r, l); if (bn_get_bit(a, i)) { pp_add_k12(l, t[j], q[j], p[j]); fp12_mul_dxs(r, r, l); } } } } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { fp12_free(l); for (j = 0; j < m; j++) { ep_free(_p[j]); } } }
int cp_ecss_sig(bn_t e, bn_t s, uint8_t *msg, int len, bn_t d) { bn_t n, k, x, r; ec_t p; uint8_t hash[MD_LEN]; uint8_t m[len + FC_BYTES]; int result = STS_OK; bn_null(n); bn_null(k); bn_null(x); bn_null(r); ec_null(p); TRY { bn_new(n); bn_new(k); bn_new(x); bn_new(r); ec_new(p); ec_curve_get_ord(n); do { bn_rand_mod(k, n); ec_mul_gen(p, k); ec_get_x(x, p); bn_mod(r, x, n); } while (bn_is_zero(r)); memcpy(m, msg, len); bn_write_bin(m + len, FC_BYTES, r); md_map(hash, m, len + FC_BYTES); if (8 * MD_LEN > bn_bits(n)) { len = CEIL(bn_bits(n), 8); bn_read_bin(e, hash, len); bn_rsh(e, e, 8 * MD_LEN - bn_bits(n)); } else { bn_read_bin(e, hash, MD_LEN); } bn_mod(e, e, n); bn_mul(s, d, e); bn_mod(s, s, n); bn_sub(s, n, s); bn_add(s, s, k); bn_mod(s, s, n); } CATCH_ANY { result = STS_ERR; } FINALLY { bn_free(n); bn_free(k); bn_free(x); bn_free(r); ec_free(p); } return result; }
void ep2_mul_fix_combs(ep2_t r, ep2_t *t, bn_t k) { int i, j, l, w, n0, p0, p1; bn_t n; if (bn_is_zero(k)) { ep2_set_infty(r); return; } bn_null(n); TRY { bn_new(n); ep2_curve_get_ord(n); l = bn_bits(n); l = ((l % EP_DEPTH) == 0 ? (l / EP_DEPTH) : (l / EP_DEPTH) + 1); n0 = bn_bits(k); p0 = (EP_DEPTH) * l - 1; w = 0; p1 = p0--; for (j = EP_DEPTH - 1; j >= 0; j--, p1 -= l) { w = w << 1; if (p1 < n0 && bn_get_bit(k, p1)) { w = w | 1; } } ep2_copy(r, t[w]); for (i = l - 2; i >= 0; i--) { ep2_dbl(r, r); w = 0; p1 = p0--; for (j = EP_DEPTH - 1; j >= 0; j--, p1 -= l) { w = w << 1; if (p1 < n0 && bn_get_bit(k, p1)) { w = w | 1; } } if (w > 0) { ep2_add(r, r, t[w]); } } ep2_norm(r, r); if (bn_sign(k) == RLC_NEG) { ep2_neg(r, r); } } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(n); } }
void ep2_mul_sim_joint(ep2_t r, ep2_t p, bn_t k, ep2_t q, bn_t l) { ep2_t t[5]; int u_i, len, offset; int8_t jsf[4 * (FP_BITS + 1)]; int i; ep2_null(t[0]); ep2_null(t[1]); ep2_null(t[2]); ep2_null(t[3]); ep2_null(t[4]); TRY { for (i = 0; i < 5; i++) { ep2_new(t[i]); } ep2_set_infty(t[0]); ep2_copy(t[1], q); ep2_copy(t[2], p); ep2_add(t[3], p, q); ep2_sub(t[4], p, q); len = 4 * (FP_BITS + 1); bn_rec_jsf(jsf, &len, k, l); ep2_set_infty(r); i = bn_bits(k); offset = MAX(i, bn_bits(l)) + 1; for (i = len - 1; i >= 0; i--) { ep2_dbl(r, r); if (jsf[i] != 0 && jsf[i] == -jsf[i + offset]) { u_i = jsf[i] * 2 + jsf[i + offset]; if (u_i < 0) { ep2_sub(r, r, t[4]); } else { ep2_add(r, r, t[4]); } } else { u_i = jsf[i] * 2 + jsf[i + offset]; if (u_i < 0) { ep2_sub(r, r, t[-u_i]); } else { ep2_add(r, r, t[u_i]); } } } ep2_norm(r, r); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { for (i = 0; i < 5; i++) { ep2_free(t[i]); } } }
void ep2_mul_fix_combd(ep2_t r, ep2_t *t, bn_t k) { int i, j, d, e, w0, w1, n0, p0, p1; bn_t n; if (bn_is_zero(k)) { ep2_set_infty(r); return; } bn_null(n); TRY { bn_new(n); ep2_curve_get_ord(n); d = bn_bits(n); d = ((d % EP_DEPTH) == 0 ? (d / EP_DEPTH) : (d / EP_DEPTH) + 1); e = (d % 2 == 0 ? (d / 2) : (d / 2) + 1); ep2_set_infty(r); n0 = bn_bits(k); p1 = (e - 1) + (EP_DEPTH - 1) * d; for (i = e - 1; i >= 0; i--) { ep2_dbl(r, r); w0 = 0; p0 = p1; for (j = EP_DEPTH - 1; j >= 0; j--, p0 -= d) { w0 = w0 << 1; if (p0 < n0 && bn_get_bit(k, p0)) { w0 = w0 | 1; } } w1 = 0; p0 = p1-- + e; for (j = EP_DEPTH - 1; j >= 0; j--, p0 -= d) { w1 = w1 << 1; if (i + e < d && p0 < n0 && bn_get_bit(k, p0)) { w1 = w1 | 1; } } ep2_add(r, r, t[w0]); ep2_add(r, r, t[(1 << EP_DEPTH) + w1]); } ep2_norm(r, r); if (bn_sign(k) == RLC_NEG) { ep2_neg(r, r); } } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(n); } }
void eb_mul_fix_combd(eb_t r, eb_t *t, bn_t k) { int i, j, d, e, w0, w1, n0, p0, p1; bn_t n; bn_null(n); TRY { bn_new(n); eb_curve_get_ord(n); d = bn_bits(n); d = ((d % EB_DEPTH) == 0 ? (d / EB_DEPTH) : (d / EB_DEPTH) + 1); e = (d % 2 == 0 ? (d / 2) : (d / 2) + 1); eb_set_infty(r); n0 = bn_bits(k); p1 = (e - 1) + (EB_DEPTH - 1) * d; for (i = e - 1; i >= 0; i--) { eb_dbl(r, r); w0 = 0; p0 = p1; for (j = EB_DEPTH - 1; j >= 0; j--, p0 -= d) { w0 = w0 << 1; if (p0 < n0 && bn_test_bit(k, p0)) { w0 = w0 | 1; } } w1 = 0; p0 = p1-- + e; for (j = EB_DEPTH - 1; j >= 0; j--, p0 -= d) { w1 = w1 << 1; if (i + e < d && p0 < n0 && bn_test_bit(k, p0)) { w1 = w1 | 1; } } eb_add(r, r, t[w0]); eb_add(r, r, t[(1 << EB_DEPTH) + w1]); } eb_norm(r, r); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(n); } }
/** * Multiplies a prime elliptic curve point by an integer using the COMBS * method. * * @param[out] r - the result. * @param[in] t - the precomputed table. * @param[in] k - the integer. */ static void ed_mul_combs_plain(ed_t r, const ed_t *t, const bn_t k) { int i, j, l, w, n0, p0, p1; bn_t n; bn_null(n); TRY { bn_new(n); ed_curve_get_ord(n); l = bn_bits(n); l = ((l % ED_DEPTH) == 0 ? (l / ED_DEPTH) : (l / ED_DEPTH) + 1); n0 = bn_bits(k); p0 = (ED_DEPTH) * l - 1; w = 0; p1 = p0--; for (j = ED_DEPTH - 1; j >= 0; j--, p1 -= l) { w = w << 1; if (p1 < n0 && bn_get_bit(k, p1)) { w = w | 1; } } ed_copy(r, t[w]); for (i = l - 2; i >= 0; i--) { ed_dbl(r, r); w = 0; p1 = p0--; for (j = ED_DEPTH - 1; j >= 0; j--, p1 -= l) { w = w << 1; if (p1 < n0 && bn_get_bit(k, p1)) { w = w | 1; } } if (w > 0) { ed_add(r, r, t[w]); } } ed_norm(r, r); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(n); } }
void eb_mul_fix_combs(eb_t r, eb_t *t, bn_t k) { int i, j, l, w, n, p0, p1; bn_t ord; bn_null(ord); TRY { bn_new(ord); eb_curve_get_ord(ord); l = bn_bits(ord); l = ((l % EB_DEPTH) == 0 ? (l / EB_DEPTH) : (l / EB_DEPTH) + 1); n = bn_bits(k); p0 = (EB_DEPTH) * l - 1; w = 0; p1 = p0--; for (j = EB_DEPTH - 1; j >= 0; j--, p1 -= l) { w = w << 1; if (p1 < n && bn_test_bit(k, p1)) { w = w | 1; } } eb_copy(r, t[w]); for (i = l - 2; i >= 0; i--) { eb_dbl(r, r); w = 0; p1 = p0--; for (j = EB_DEPTH - 1; j >= 0; j--, p1 -= l) { w = w << 1; if (p1 < n && bn_test_bit(k, p1)) { w = w | 1; } } if (w > 0) { eb_add(r, r, t[w]); } } eb_norm(r, r); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(ord); } }
void ed_mul_pre_nafwi(ed_t *t, const ed_t p) { int l; bn_t n; bn_null(n); TRY { bn_new(n); ed_curve_get_ord(n); l = bn_bits(n) + 1; l = ((l % ED_DEPTH) == 0 ? (l / ED_DEPTH) : (l / ED_DEPTH) + 1); ed_copy(t[0], p); for (int i = 1; i < l; i++) { ed_dbl(t[i], t[i - 1]); for (int j = 1; j < ED_DEPTH; j++) { ed_dbl(t[i], t[i]); } } ed_norm_sim(t + 1, (const ed_t *)t + 1, l - 1); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(n); } }
void ep2_mul(ep2_t r, ep2_t p, bn_t k) { int i, l; ep2_t t; ep2_null(t); TRY { ep2_new(t); l = bn_bits(k); if (bn_get_bit(k, l - 1)) { ep2_copy(t, p); } else { ep2_set_infty(t); } for (i = l - 2; i >= 0; i--) { ep2_dbl(t, t); if (bn_get_bit(k, i)) { ep2_add(t, t, p); } } ep2_copy(r, t); ep2_norm(r, r); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { ep2_free(t); } }
void fp2_norm_low(fp2_t c, fp2_t a) { fp2_t t; bn_t b; fp2_null(t); bn_null(b); TRY { fp2_new(t); bn_new(b); #if FP_PRIME == 158 fp_dbl(t[0], a[0]); fp_dbl(t[0], t[0]); fp_sub(t[0], t[0], a[1]); fp_dbl(t[1], a[1]); fp_dbl(t[1], t[1]); fp_add(c[1], a[0], t[1]); fp_copy(c[0], t[0]); #elif defined(FP_QNRES) /* If p = 3 mod 8, (1 + i) is a QNR/CNR. */ fp_neg(t[0], a[1]); fp_add(c[1], a[0], a[1]); fp_add(c[0], t[0], a[0]); #else switch (fp_prime_get_mod8()) { case 3: /* If p = 3 mod 8, (1 + u) is a QNR/CNR. */ fp_neg(t[0], a[1]); fp_add(c[1], a[0], a[1]); fp_add(c[0], t[0], a[0]); break; case 5: /* If p = 5 mod 8, (u) is a QNR/CNR. */ fp2_mul_art(c, a); break; case 7: /* If p = 7 mod 8, we choose (2^(lg_4(b-1)) + u) as QNR/CNR. */ fp2_mul_art(t, a); fp2_dbl(c, a); fp_prime_back(b, ep_curve_get_b()); for (int i = 1; i < bn_bits(b) / 2; i++) { fp2_dbl(c, c); } fp2_add(c, c, t); break; default: THROW(ERR_NO_VALID); break; } #endif } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { fp2_free(t); bn_free(b); } }
int cp_ecss_gen(bn_t d, ec_t q) { bn_t n; int result = STS_OK; bn_null(n); TRY { bn_new(n); ec_curve_get_ord(n); do { bn_rand(d, BN_POS, bn_bits(n)); bn_mod(d, d, n); } while (bn_is_zero(d)); ec_mul_gen(q, d); } CATCH_ANY { result = STS_ERR; } FINALLY { bn_free(n); } return result; }
/** * Computes c = a ^ b mod m. * * @param c - the result. * @param a - the basis. * @param b - the exponent. * @param m - the modulus. */ static void bn_exp(bn_t c, const bn_t a, const bn_t b, const bn_t m) { int i, l; bn_t t; bn_null(t); TRY { bn_new(t); l = bn_bits(b); bn_copy(t, a); for (i = l - 2; i >= 0; i--) { bn_sqr(t, t); bn_mod(t, t, m); if (bn_get_bit(b, i)) { bn_mul(t, t, a); bn_mod(t, t, m); } } bn_copy(c, t); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(t); } }
void ep2_mul_pre_nafwi(ep2_t *t, ep2_t p) { int l; bn_t n; bn_null(n); TRY { bn_new(n); ep2_curve_get_ord(n); l = bn_bits(n) + 1; l = ((l % EP_DEPTH) == 0 ? (l / EP_DEPTH) : (l / EP_DEPTH) + 1); ep2_copy(t[0], p); for (int i = 1; i < l; i++) { ep2_dbl(t[i], t[i - 1]); for (int j = 1; j < EP_DEPTH; j++) { ep2_dbl(t[i], t[i]); } } } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(n); } }
void ed_mul_basic(ed_t r, const ed_t p, const bn_t k) { ed_t t; ed_null(t); if (bn_is_zero(k) || ed_is_infty(p)) { ed_set_infty(r); return; } TRY { ed_new(t); ed_copy(t, p); for (int i = bn_bits(k) - 2; i >= 0; i--) { ed_dbl(t, t); if (bn_get_bit(k, i)) { ed_add(t, t, p); } } ed_norm(r, t); if (bn_sign(k) == RLC_NEG) { ed_neg(r, r); } } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { ed_free(t); } }
status_t element_random(element_t e) { if(e->isInitialized == TRUE) { if(e->type == ZR) { bn_t n; bn_inits(n); g1_get_ord(n); bn_t t = e->bn; bn_rand(t, BN_POS, bn_bits(n)); bn_mod(t, t, n); bn_free(n); } else if(e->type == G1) { g1_rand(e->g1); } else if(e->type == G2) { g2_rand(e->g2); } else if(e->type == GT) { gt_rand(e->gt); } return ELEMENT_OK; } return ELEMENT_UNINITIALIZED; }
void fb4_exp(fb4_t c, fb4_t a, bn_t b) { fb4_t t; fb4_null(t); TRY { fb4_new(t); fb4_copy(t, a); for (int i = bn_bits(b) - 2; i >= 0; i--) { fb4_sqr(t, t); if (bn_get_bit(b, i)) { fb4_mul(t, t, a); } } fb4_copy(c, t); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { fb4_free(t); } }
void ep2_map(ep2_t p, uint8_t *msg, int len) { bn_t x; fp2_t t0; uint8_t digest[MD_LEN]; bn_null(x); fp2_null(t0); TRY { bn_new(x); fp2_new(t0); md_map(digest, msg, len); bn_read_bin(x, digest, MIN(FP_BYTES, MD_LEN)); fp_prime_conv(p->x[0], x); fp_zero(p->x[1]); fp_set_dig(p->z[0], 1); fp_zero(p->z[1]); while (1) { ep2_rhs(t0, p); if (fp2_srt(p->y, t0)) { p->norm = 1; break; } fp_add_dig(p->x[0], p->x[0], 1); } switch (ep_param_get()) { case BN_P158: case BN_P254: case BN_P256: case BN_P638: ep2_mul_cof_bn(p, p); break; case B12_P638: ep2_mul_cof_b12(p, p); break; default: /* Now, multiply by cofactor to get the correct group. */ ep2_curve_get_cof(x); if (bn_bits(x) < BN_DIGIT) { ep2_mul_dig(p, p, x->dp[0]); } else { ep2_mul(p, p, x); } break; } } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(x); fp2_free(t0); } }
void eb_mul_pre_combs(eb_t *t, eb_t p) { int i, j, l; bn_t ord; bn_null(ord); TRY { bn_new(ord); eb_curve_get_ord(ord); l = bn_bits(ord); l = ((l % EB_DEPTH) == 0 ? (l / EB_DEPTH) : (l / EB_DEPTH) + 1); eb_set_infty(t[0]); eb_copy(t[1], p); for (j = 1; j < EB_DEPTH; j++) { eb_dbl(t[1 << j], t[1 << (j - 1)]); for (i = 1; i < l; i++) { eb_dbl(t[1 << j], t[1 << j]); } for (i = 1; i < (1 << j); i++) { eb_add(t[(1 << j) + i], t[1 << j], t[i]); } } eb_norm_sim(t + 2, t + 2, EB_TABLE_COMBS - 2); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(ord); } }
void bn_mxp_monty(bn_t c, const bn_t a, const bn_t b, const bn_t m) { bn_t tab[2], u; dig_t mask; int t; bn_null(tab[0]); bn_null(tab[1]); bn_null(u); TRY { bn_new(u); bn_mod_pre(u, m); bn_new(tab[0]); bn_new(tab[1]); #if BN_MOD == MONTY bn_set_dig(tab[0], 1); bn_mod_monty_conv(tab[0], tab[0], m); bn_mod_monty_conv(tab[1], a, m); #else bn_set_dig(tab[0], 1); bn_copy(tab[1], a); #endif for (int i = bn_bits(b) - 1; i >= 0; i--) { int j = bn_get_bit(b, i); dv_swap_cond(tab[0]->dp, tab[1]->dp, BN_DIGS, j ^ 1); mask = -(j ^ 1); t = (tab[0]->used ^ tab[1]->used) & mask; tab[0]->used ^= t; tab[1]->used ^= t; bn_mul(tab[0], tab[0], tab[1]); bn_mod(tab[0], tab[0], m, u); bn_sqr(tab[1], tab[1]); bn_mod(tab[1], tab[1], m, u); dv_swap_cond(tab[0]->dp, tab[1]->dp, BN_DIGS, j ^ 1); mask = -(j ^ 1); t = (tab[0]->used ^ tab[1]->used) & mask; tab[0]->used ^= t; tab[1]->used ^= t; } #if BN_MOD == MONTY bn_mod_monty_back(c, tab[0], m); #else bn_copy(c, tab[0]); #endif } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(tab[1]); bn_free(tab[0]); bn_free(u); } }
void ed_mul_pre_combs(ed_t *t, const ed_t p) { int i, j, l; bn_t n; bn_null(n); TRY { bn_new(n); ed_curve_get_ord(n); l = bn_bits(n); l = ((l % ED_DEPTH) == 0 ? (l / ED_DEPTH) : (l / ED_DEPTH) + 1); #if defined(ED_ENDOM) if (ed_curve_is_endom()) { l = bn_bits(n); l = ((l % (2 * ED_DEPTH)) == 0 ? (l / (2 * ED_DEPTH)) : (l / (2 * ED_DEPTH)) + 1); } #endif ed_set_infty(t[0]); ed_copy(t[1], p); for (j = 1; j < ED_DEPTH; j++) { ed_dbl(t[1 << j], t[1 << (j - 1)]); for (i = 1; i < l; i++) { ed_dbl(t[1 << j], t[1 << j]); } #if defined(ED_MIXED) ed_norm(t[1 << j], t[1 << j]); #endif for (i = 1; i < (1 << j); i++) { ed_add(t[(1 << j) + i], t[i], t[1 << j]); } } ed_norm_sim(t + 2, (const ed_t *)t + 2, ED_TABLE_COMBS - 2); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(n); } }
int bn_ham(const bn_t a) { int c = 0; for (int i = 0; i < bn_bits(a); i++) { c += bn_get_bit(a, i); } return c; }
void ep_curve_set_endom(const fp_t b, const ep_t g, const bn_t r, const bn_t h, const fp_t beta, const bn_t l) { int bits = bn_bits(r); ctx_t *ctx = core_get(); ctx->ep_is_endom = 1; ctx->ep_is_super = 0; fp_zero(ctx->ep_a); fp_copy(ctx->ep_b, b); detect_opt(&(ctx->ep_opt_a), ctx->ep_a); detect_opt(&(ctx->ep_opt_b), ctx->ep_b); #if EP_MUL == LWNAF || EP_FIX == COMBS || EP_FIX == LWNAF || EP_SIM == INTER || !defined(STRIP) fp_copy(ctx->beta, beta); bn_gcd_ext_mid(&(ctx->ep_v1[1]), &(ctx->ep_v1[2]), &(ctx->ep_v2[1]), &(ctx->ep_v2[2]), l, r); /* l = v1[1] * v2[2] - v1[2] * v2[1], r = l / 2. */ bn_mul(&(ctx->ep_v1[0]), &(ctx->ep_v1[1]), &(ctx->ep_v2[2])); bn_mul(&(ctx->ep_v2[0]), &(ctx->ep_v1[2]), &(ctx->ep_v2[1])); bn_sub(&(ctx->ep_r), &(ctx->ep_v1[0]), &(ctx->ep_v2[0])); bn_hlv(&(ctx->ep_r), &(ctx->ep_r)); /* v1[0] = round(v2[2] * 2^|n| / l). */ bn_lsh(&(ctx->ep_v1[0]), &(ctx->ep_v2[2]), bits + 1); if (bn_sign(&(ctx->ep_v1[0])) == BN_POS) { bn_add(&(ctx->ep_v1[0]), &(ctx->ep_v1[0]), &(ctx->ep_r)); } else { bn_sub(&(ctx->ep_v1[0]), &(ctx->ep_v1[0]), &(ctx->ep_r)); } bn_dbl(&(ctx->ep_r), &(ctx->ep_r)); bn_div(&(ctx->ep_v1[0]), &(ctx->ep_v1[0]), &(ctx->ep_r)); if (bn_sign(&ctx->ep_v1[0]) == BN_NEG) { bn_add_dig(&(ctx->ep_v1[0]), &(ctx->ep_v1[0]), 1); } /* v2[0] = round(v1[2] * 2^|n| / l). */ bn_lsh(&(ctx->ep_v2[0]), &(ctx->ep_v1[2]), bits + 1); if (bn_sign(&(ctx->ep_v2[0])) == BN_POS) { bn_add(&(ctx->ep_v2[0]), &(ctx->ep_v2[0]), &(ctx->ep_r)); } else { bn_sub(&(ctx->ep_v2[0]), &(ctx->ep_v2[0]), &(ctx->ep_r)); } bn_div(&(ctx->ep_v2[0]), &(ctx->ep_v2[0]), &(ctx->ep_r)); if (bn_sign(&ctx->ep_v2[0]) == BN_NEG) { bn_add_dig(&(ctx->ep_v2[0]), &(ctx->ep_v2[0]), 1); } bn_neg(&(ctx->ep_v2[0]), &(ctx->ep_v2[0])); #endif ep_norm(&(ctx->ep_g), g); bn_copy(&(ctx->ep_r), r); bn_copy(&(ctx->ep_h), h); #if defined(EP_PRECO) ep_mul_pre((ep_t *)ep_curve_get_tab(), &(ctx->ep_g)); #endif }
void bn_gen_prime_basic(bn_t a, int bits) { while (1) { do { bn_rand(a, BN_POS, bits); } while (bn_bits(a) != bits); if (bn_is_prime(a)) { return; } } }
void bn_mxp_basic(bn_t c, const bn_t a, const bn_t b, const bn_t m) { int i, l; bn_t t, u, r; if (bn_is_zero(b)) { bn_set_dig(c, 1); return; } bn_null(t); bn_null(u); bn_null(r); TRY { bn_new(t); bn_new(u); bn_new(r); bn_mod_pre(u, m); l = bn_bits(b); #if BN_MOD == MONTY bn_mod_monty_conv(t, a, m); #else bn_copy(t, a); #endif bn_copy(r, t); for (i = l - 2; i >= 0; i--) { bn_sqr(r, r); bn_mod(r, r, m, u); if (bn_get_bit(b, i)) { bn_mul(r, r, t); bn_mod(r, r, m, u); } } #if BN_MOD == MONTY bn_mod_monty_back(c, r, m); #else bn_copy(c, r); #endif } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(t); bn_free(u); bn_free(r); } }
void ed_mul_pre_basic(ed_t *t, const ed_t p) { bn_t n; bn_null(n); TRY { bn_new(n); ed_curve_get_ord(n); ed_copy(t[0], p); for (int i = 1; i < bn_bits(n); i++) { ed_dbl(t[i], t[i - 1]); } ed_norm_sim(t + 1, (const ed_t *)t + 1, bn_bits(n) - 1); } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(n); } }
void ed_mul_fix_basic(ed_t r, const ed_t *t, const bn_t k) { int i, l; l = bn_bits(k); ed_set_infty(r); for (i = 0; i < l; i++) { if (bn_get_bit(k, i)) { ed_add(r, r, t[i]); } } ed_norm(r, r); }
void ep2_mul_fix_basic(ep2_t r, ep2_t *t, bn_t k) { int i, l; l = bn_bits(k); ep2_set_infty(r); for (i = 0; i < l; i++) { if (bn_get_bit(k, i)) { ep2_add(r, r, t[i]); } } ep2_norm(r, r); }
void ed_mul_monty(ed_t r, const ed_t p, const bn_t k) { ed_t t[2]; ed_null(t[0]); ed_null(t[1]); if (bn_is_zero(k) || ed_is_infty(p)) { ed_set_infty(r); return; } TRY { ed_new(t[0]); ed_new(t[1]); ed_set_infty(t[0]); ed_copy(t[1], p); for (int i = bn_bits(k) - 1; i >= 0; i--) { int j = bn_get_bit(k, i); dv_swap_cond(t[0]->x, t[1]->x, RLC_FP_DIGS, j ^ 1); dv_swap_cond(t[0]->y, t[1]->y, RLC_FP_DIGS, j ^ 1); dv_swap_cond(t[0]->z, t[1]->z, RLC_FP_DIGS, j ^ 1); #if ED_ADD == EXTND dv_swap_cond(t[0]->t, t[1]->t, RLC_FP_DIGS, j ^ 1); #endif ed_add(t[0], t[0], t[1]); ed_dbl(t[1], t[1]); dv_swap_cond(t[0]->x, t[1]->x, RLC_FP_DIGS, j ^ 1); dv_swap_cond(t[0]->y, t[1]->y, RLC_FP_DIGS, j ^ 1); dv_swap_cond(t[0]->z, t[1]->z, RLC_FP_DIGS, j ^ 1); #if ED_ADD == EXTND dv_swap_cond(t[0]->t, t[1]->t, RLC_FP_DIGS, j ^ 1); #endif } ed_norm(r, t[0]); if (bn_sign(k) == RLC_NEG) { ed_neg(r, r); } } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { ed_free(t[1]); ed_free(t[0]); } }
void ep2_mul_pre_combd(ep2_t *t, ep2_t p) { int i, j, d, e; bn_t n; bn_null(n); TRY { bn_new(n); ep2_curve_get_ord(n); d = bn_bits(n); d = ((d % EP_DEPTH) == 0 ? (d / EP_DEPTH) : (d / EP_DEPTH) + 1); e = (d % 2 == 0 ? (d / 2) : (d / 2) + 1); ep2_set_infty(t[0]); ep2_copy(t[1], p); for (j = 1; j < EP_DEPTH; j++) { ep2_dbl(t[1 << j], t[1 << (j - 1)]); for (i = 1; i < d; i++) { ep2_dbl(t[1 << j], t[1 << j]); } #if defined(EP_MIXED) ep2_norm(t[1 << j], t[1 << j]); #endif for (i = 1; i < (1 << j); i++) { ep2_add(t[(1 << j) + i], t[i], t[1 << j]); } } ep2_set_infty(t[1 << EP_DEPTH]); for (j = 1; j < (1 << EP_DEPTH); j++) { ep2_dbl(t[(1 << EP_DEPTH) + j], t[j]); for (i = 1; i < e; i++) { ep2_dbl(t[(1 << EP_DEPTH) + j], t[(1 << EP_DEPTH) + j]); } } #if defined(EP_MIXED) for (i = 1; i < RELIC_EP_TABLE_COMBD; i++) { ep2_norm(t[i], t[i]); } #endif } CATCH_ANY { THROW(ERR_CAUGHT); } FINALLY { bn_free(n); } }