diff --git a/autogen.sh b/autogen.sh
index 1eb7ce9..526abc5 100755
--- a/autogen.sh
+++ b/autogen.sh
@@ -2,7 +2,7 @@
# simple autogen script that generates basic layout for autotools.
-COMMON_CPPFLAGS="-I/usr/local/include -I\$(srcdir)/include/"
+COMMON_CPPFLAGS="-I/usr/local/include"
COMMON_CFLAGS="-Wall"
COMMON_LDFLAGS="-L/usr/local/lib"
COMMON_LDADD=""
@@ -16,19 +16,14 @@ DISTDIRS=""
echo "AUTOMAKE_OPTIONS = subdir-objects" >>$OUT
echo "dist_noinst_SCRIPTS = autogen.sh" `for i in $DISTDIRS ; do find \$i -type f ; done | tr "\n" " " ` >>$OUT
-echo "noinst_HEADERS = `find include/ -type f -name \*.h |tr \"\n\" \" \" `" >>$OUT
-echo "noinst_HEADERS += `find lib/ -type f -name \*.h |tr \"\n\" \" \" `" >>$OUT
-
echo "bin_PROGRAMS = ccr" >>$OUT
echo "ccrdir = src/" >>$OUT
echo "ccr_SOURCES = `( find src/ -type f -name \*.c ; find src/ -type f -name \*.cpp ) |tr \"\n\" \" \" ` " >>$OUT
-echo "ccr_SOURCES += `(find lib/ -type f -name *.c; find lib/ -type f -name *.cpp)|tr \"\n\" \" \" ` " >>$OUT
-echo "noinst_HEADERS += `find src/ -type f -name \*.h |tr \"\n\" \" \" `" >>$OUT
+echo "noinst_HEADERS = `find src/ -type f -name \*.h |tr \"\n\" \" \" `" >>$OUT
echo "ccr_CPPFLAGS = -I\$(srcdir)/$i/ ${COMMON_CPPFLAGS}" >>$OUT
echo "ccr_CFLAGS = ${COMMON_CFLAGS}" >>$OUT
echo "ccr_LDFLAGS = ${COMMON_LDFLAGS}" >>$OUT
echo "ccr_LDADD = -lgmp ${COMMON_LDADD} " >>$OUT
-[ -f "src/Makefile.am.extra" ] && cat "src/Makefile.am.extra" >>$OUT
libtoolize --force && aclocal && autoconf && automake --add-missing
diff --git a/lib/cfs_qd.cpp b/lib/cfs_qd.cpp
deleted file mode 100644
index 0989011..0000000
--- a/lib/cfs_qd.cpp
+++ /dev/null
@@ -1,580 +0,0 @@
-
-/*
- * This file is part of Codecrypt.
- *
- * Codecrypt is free software: you can redistribute it and/or modify it
- * under the terms of the GNU Lesser General Public License as published by
- * the Free Software Foundation, either version 3 of the License, or (at
- * your option) any later version.
- *
- * Codecrypt is distributed in the hope that it will be useful, but WITHOUT
- * ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
- * FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public
- * License for more details.
- *
- * You should have received a copy of the GNU Lesser General Public License
- * along with Codecrypt. If not, see .
- */
-
-#include "codecrypt.h"
-
-using namespace ccr;
-using namespace ccr::cfs_qd;
-
-#include "decoding.h"
-#include "qd_utils.h"
-
-#include
-
-int cfs_qd::generate (pubkey&pub, privkey&priv, prng&rng,
- uint m, uint T, uint t, uint block_discard)
-{
- priv.fld.create (m);
- priv.T = T;
- uint block_size = 1 << T;
- if (t > block_size) return 2;
- priv.t = t;
-
- //convenience
- gf2m&fld = priv.fld;
- std::vector&essence = priv.essence;
-
- std::vector support, Hsig;
- polynomial g;
- uint i, j;
-
- //prepare for data
- Hsig.resize (fld.n);
- support.resize (fld.n);
- essence.resize (m + 1);
- //note that q=2^m, algo. n=q/2, log n = m-1
-
- //retry generating until goppa code is produced.
- for (;;) {
-
- std::cout << "attempt" << std::endl;
-
- std::set used;
- used.clear();
-
- //first off, compute the H signature
-
- Hsig[0] = choose_random (fld.n, rng, used);
- essence[m] = fld.inv (Hsig[0]);
- //essence[m] is now used as precomputed 1/h_0
-
- for (uint s = 0; s < m; ++s) {
- i = 1 << s; //i = 2^s
-
- Hsig[i] = choose_random (fld.n, rng, used);
- essence[s] = fld.add (essence[m], fld.inv (Hsig[i]) );
- used.insert (fld.inv (essence[s]) );
-
- for (j = 1; j < i; ++j) {
- uint hij = fld.inv
- (fld.add
- (fld.inv (Hsig[i]),
- fld.add (
- fld.inv (Hsig[j]),
- essence[m]
- ) ) );
- if ( (!Hsig[i]) || (!Hsig[j]) ) hij = 0;
- Hsig[i + j] = hij;
- if (hij) {
- used.insert (Hsig[i + j]);
- /*used.insert (fld.inv
- (fld.add
- (fld.inv (Hsig[i + j]),
- essence[m]) ) );*/
- }
- }
- }
-
- std::cout << "Gen Hsig: ";
- for (i = 0; i < fld.n; ++i) std::cout << Hsig[i] << ' ';
- std::cout << std::endl;
-
- //let's play with blocks.
- uint block_size = 1 << T,
- h_block_count = fld.n / block_size,
- block_count = h_block_count - block_discard;
-
- //check if we have enough good blocks.
- std::vector block_status;
- uint badblocks;
- block_status.resize (h_block_count);
-
- badblocks = 0;
- for (i = 0; i < h_block_count; ++i) {
- block_status[i] = true;
- for (j = 0; j < block_size; ++j)
- if (!Hsig[i * block_size + j]) {
- block_status[i] = false;
- break;
- }
- if (!block_status[i]) ++badblocks;
- }
-
- std::cout << "badblocks: " << badblocks << std::endl;
-
- if (badblocks > block_discard) continue; //don't have enough good blocks
- if (!block_status[0]) continue; //cannot assemble goppa poly
-
- std::cout << "lol contd." << std::endl;
-
- //reconstruct g
- used.clear();
- g.clear();
- g.resize (1, 1); //g(x)=1 so we can multiply it
- polynomial tmp;
- tmp.resize (2, 1); //tmp(x)=x-1
- bool consistent = true;
- for (i = 0; i < t; ++i) {
- //tmp(x)=x-z=x-(1/h_i) where h_i is squared!
- tmp[0] = fld.inv (Hsig[i]);
- if (used.count (tmp[0]) ) {
- consistent = false;
- break;
- }
- used.insert (tmp[0]);
- g.mult (tmp, fld);
- }
- if (!consistent) continue; //retry
-
- std::cout << "lol have g: " << g;
-
- //compute the support, retry if it has two equal elements.
- for (i = 0; i < fld.n; ++i) {
- if (!block_status[i / block_size]) continue;
- support[i] = fld.add (
- fld.inv (Hsig[i]),
- essence[m]);
-
- std::cout << "support " << i << " = " << support[i] << std::endl;
- if (used.count (support[i]) ) {
- std::cout << "support inconsistent at " << i << std::endl;
- ++badblocks;
- block_status[i / block_size] = false;
- break;
- }
-
- used.insert (support[i]);
- }
-
- std::cout << "bad: " << badblocks << std::endl;
- if (badblocks > block_discard) continue;
-
- //assemble blocks to bl
- std::vector bl, blp;
- bl.resize (h_block_count);
- for (i = 0; i < h_block_count; ++i) {
- bl[i].resize (block_size);
- for (j = 0; j < block_size; ++j)
- bl[i][j] = Hsig[i * block_size + j];
- }
-
- //permute the blocks. first move the damaged to discard area
- priv.block_perm.generate_identity (h_block_count);
- uint oks = h_block_count;
- for (i = 0; i < oks; ++i)
- if (!block_status[i]) {
- std::cout << "removing one" << std::endl;
- --oks;
- priv.block_perm[i] = oks;
- priv.block_perm[oks] = i;
- //swap block statuses as well
- bool tmp = block_status[i];
- block_status[i] = block_status[oks];
- block_status[oks] = tmp;
- --i;
- }
- std::cout << "BLOCK " << priv.block_perm;
- permutation rest_perm;
- rest_perm.generate_random (oks, rng);
- //permute the undamaged part of block_perm by hand TODO FIXME
- //for (i = 0; i < oks; ++i) rest_perm[i] = priv.block_perm[rest_perm[i]];
- //for (i = 0; i < oks; ++i) priv.block_perm[i] = rest_perm[i];
-
- //now we can safely permute and discard blocks
- priv.block_perm.permute (bl, blp);
- blp.resize (block_count);
-
- //permute individual blocks
- priv.block_perms.resize (block_count);
- bl.resize (blp.size() );
- for (i = 0; i < block_count; ++i) {
- priv.block_perms[i] = rng.random (block_size);
- permutation::permute_dyadic (priv.block_perms[i],
- blp[i], bl[i]);
- }
-
- //construct H
- pub.qd_sigs.resize (fld.m);
- bvector col;
- bvector block;
- for (i = 0; i < fld.m; ++i)
- pub.qd_sigs[i].resize (block_count * block_size);
- for (i = 0; i < block_count; ++i) {
- col.from_poly_cotrace (bl[i], fld);
- for (j = 0; j < fld.m; ++j) {
- col.get_block (j * block_size,
- block_size, block);
-
- pub.qd_sigs[j].set_block
- (block, block_size * i);
- }
- }
-
- //finish the pubkey
- pub.T = T;
- pub.t = t;
-
- return 0;
- }
-}
-
-int privkey::prepare()
-{
- uint s, i, j, k;
- std::vector Hsig, support;
- uint omega;
-
- uint block_count = block_perms.size(),
- block_size = 1 << T;
-
- //compute H signature from essence
- Hsig.resize (fld.n);
- Hsig[0] = fld.inv (essence[fld.m]);
- for (s = 0; s < fld.m; ++s) {
- i = 1 << s; //i = 2^s
-
- Hsig[i] = fld.inv (fld.add (essence[s], essence[fld.m]) );
-
- for (j = 1; j < i; ++j)
- Hsig[i + j] = fld.inv
- (fld.add
- (fld.inv (Hsig[i]),
- fld.add (
- fld.inv (Hsig[j]),
- essence[fld.m]
- ) ) );
- }
- std::cout << "Gen Hsig: ";
- for (i = 0; i < fld.n; ++i) std::cout << Hsig[i] << ' ';
- std::cout << std::endl;
-
-
- //goppa polynomial with omega=0
- std::set used;
- used.clear();
-
- polynomial tmp;
- g.clear();
- g.resize (1, 1); //g(x)=1
- tmp.clear();
- tmp.resize (2, 1); //tmp(x)=x+1
- for (i = 0; i < t; ++i) {
- tmp[0] = fld.inv (Hsig[i]); //tmp(x)=x+1/h_i
- if (used.count (tmp[0]) )
- return 1;
- std::cout << tmp[0] << std::endl;
- used.insert (tmp[0]);
- g.mult (tmp, fld);
- }
-
- std::cout << "HERE 1" << std::endl;
- //compute the support with omega=0
- support.resize (fld.n);
- for (i = 0; i < fld.n; ++i) {
- //don't compute with discarded support
- if (block_perm[i / block_size] >= block_count) continue;
- support[i] = fld.add
- (fld.inv (Hsig[i]),
- essence[fld.m]);
- std::cout << "support " << i << " = " << support[i] << std::endl;
- if (used.count (support[i]) ) //invalid support
- return 1;
- used.insert (support[i]);
- }
-
- std::cout << "HERE LOLOLOLOLOL" << std::endl;
- //choose omega
- omega = fld.n;
- for (i = 0; i < fld.n; ++i)
- if (!used.count (i) ) {
- omega = i;
- break;
- }
- if (omega == fld.n) return 1;
-
- //modify support to omega-ized version
- for (i = 0; i < support.size(); ++i)
- support[i] = fld.add (support[i], omega);
-
- //modify g to omega-ized version
- g.clear();
- tmp.clear();
- g.resize (1, 1); //g(x)=1
- tmp.resize (2, 1); //tmp(x)=x+1
- for (i = 0; i < t; ++i) {
- tmp[0] = fld.add (fld.inv (Hsig[i]), omega);
- g.mult (tmp, fld);
- }
-
- g.compute_square_root_matrix (sqInv, fld);
-
- // prepare permuted support, from that prepare permuted check matrix
- // (so that it can be applied directly)
- uint pos;
- std::vector sbl1, sbl2, permuted_support;
-
- sbl1.resize (block_size);
- sbl2.resize (block_size);
- permuted_support.resize (block_size * block_count);
-
- //permute support
- for (i = 0; i < fld.n / block_size; ++i) {
- pos = block_perm[i];
- if (pos >= block_count) continue; //was discarded
-
- //permute i-th block of support
- for (j = 0; j < block_size; ++j)
- sbl1[j] = support[j + i * block_size];
-
- permutation::permute_dyadic (block_perms[pos], sbl1, sbl2);
-
- //store support to permuted support
- for (j = 0; j < block_size; ++j)
- permuted_support[j + pos * block_size] = sbl2[j];
- }
-
- //convert the permuted support to actual lookup
- support_pos.clear();
- //fld.n in support lookup means that it isn't there (we don't have -1)
- support_pos.resize (fld.n, fld.n);
- for (i = 0; i < block_size * block_count; ++i)
- support_pos[permuted_support[i]] = i;
-
- /*
- * TODO move this to separate function
- *
- * prepare the matrix to compute decodable syndrome from QD matrix. From Barreto's slides:
- *
- * A is public check matrix
- * H is private check matrix producing decodable syndromes
- *
- * H=SA for some S
- * therefore if
- *
- * synd = A * codeword
- *
- * then
- *
- * S*synd = H*codeword
- *
- * and S = H * A^T * (A * A^T)^-1
- */
-
- std::vector > ma, mb, tmpa, tmph;
- std::vector t1, t2;
-
- /*
- * First, precompute the matrices A and H
- */
-
- tmpa.resize (t);
- tmph.resize (t);
- for (i = 0; i < t; ++i) {
- tmpa[i].resize (fld.n);
- tmph[i].resize (fld.n);
- }
-
- for (i = 0; i < t; ++i)
- permutation::permute_dyadic (i, Hsig, tmpa[i]);
-
- std::cout << "TMPA" << std::endl;
- for (i = 0; i < t; ++i) {
- for (j = 0; j < fld.n; ++j) std::cout << tmpa[i][j] << ' ';
- std::cout << std::endl;
- }
-
-
- polynomial tmpcol;
- for (i = 0; i < fld.n; ++i) {
- tmpcol.resize (2);
- tmpcol[0] = support[i];
- tmpcol[1] = 1;
- tmpcol.inv (g, fld);
- tmpcol.resize (t, 0);
- for (j = 0; j < t; ++j) tmph[j][i] = tmpcol[j];
- }
-
- /*
- * compute H * H^T to ma and A * H^T to mb.
- */
-
- ma.resize (t);
- mb.resize (t);
- for (i = 0; i < t; ++i) {
- ma[i].resize (t, 0);
- mb[i].resize (t, 0);
- }
-
- for (i = 0; i < t; ++i) for (j = 0; j < t; ++j) {
- for (k = 0; k < fld.n; ++k) {
- ma[i][j] = fld.add (ma[i][j], fld.mult (tmph[i][k], tmph[j][k]) );
- mb[i][j] = fld.add (mb[i][j], fld.mult (tmpa[i][k], tmph[j][k]) );
- }
- }
-
- std::cout << "MA" << std::endl;
- for (i = 0; i < t; ++i) {
- for (j = 0; j < t; ++j) std::cout << ma[i][j] << ' ';
- std::cout << std::endl;
- }
-
- std::cout << "MB" << std::endl;
- for (i = 0; i < t; ++i) {
- for (j = 0; j < t; ++j) std::cout << mb[i][j] << ' ';
- std::cout << std::endl;
- }
-
- /*
- * now invert mb into ma as (mb|ma) to (I|ma*mb^-1)
- *
- * (result will be transposed, but that's actually good for our purpose)
- */
-
- uint x;
- //gauss step
- for (i = 0; i < t; ++i) {
- //find pivot
- for (j = i; j < t; ++j) if (mb[j][i] != 0) break;
- if (j >= t) return 1; //no pivot -> not invertible
- if (j > i) {
- ma[j].swap (ma[i]);
- mb[j].swap (mb[i]);
- }
- //normalize
- x = fld.inv (mb[i][i]);
- for (j = 0; j < t; ++j) {
- ma[i][j] = fld.mult (ma[i][j], x);
- mb[i][j] = fld.mult (mb[i][j], x);
- }
- //zero rows below
- for (j = i + 1; j < t; ++j) {
- x = mb[j][i];
- if (x == 0) continue;
- for (k = 0; k < t; ++k) {
- ma[j][k] = fld.add (ma[j][k], fld.mult (x, ma[i][k]) );
- mb[j][k] = fld.add (mb[j][k], fld.mult (x, mb[i][k]) );
- }
- }
- }
-
- //jordan step
- std::cout << "jordan step..." << std::endl;
- for (i = 0; i < t; ++i) {
- for (j = i + 1; j < t; ++j) {
- x = mb[t - j - 1][t - i - 1];
- if (x == 0) continue;
- for (k = 0; k < t; ++k) {
- ma[t - j - 1][k] = fld.add (ma[t - j - 1][k], fld.mult (x, ma[t - i - 1][k]) );
- mb[t - j - 1][k] = fld.add (mb[t - j - 1][k], fld.mult (x, mb[t - i - 1][k]) );
- }
- }
- }
-
- //result is now transposed in ma.
- syndS.resize (t);
- for (i = 0; i < t; ++i) {
- syndS[i].resize (t);
- for (j = 0; j < t; ++j) syndS[i][j] = ma[i][j];
- }
-
- std::cout << "SyndS is OKAY!" << std::endl;
-
- polynomial decsynd, loc;
- for (i = 0; i < t; ++i)
- decsynd.add_mult (syndS[i], Hsig[i], fld);
- compute_goppa_error_locator (decsynd, fld, g, sqInv, loc);
- std::cout << "TEST LOCATOR: " << loc;
-
- return 0;
-}
-
-int privkey::sign (const bvector& hash, bvector&signature,
- uint delta, uint attempts, prng&rng)
-{
- if (hash.size() != hash_size() ) return 2;
-
- polynomial synd, decsynd, tmp, loc;
- bvector ev, h2;
-
- uint i;
-
- for (uint att = 0; att < attempts; ++att) {
- h2 = hash;
- for (i = 0; i < delta; ++i) {
- uint p = rng.random (h2.size() );
- h2[p] = !h2[p];
- }
-
- h2.to_poly_cotrace (synd, fld);
-
- std::cout << "SYND" << synd;
-
- decsynd.clear();
- for (i = 0; i < t; ++i)
- decsynd.add_mult (syndS[i], synd[i], fld);
-
- std::cout << "SYND PREP" << decsynd;
-
- compute_goppa_error_locator (decsynd, fld, g, sqInv, loc);
- if (!evaluate_error_locator_trace (loc, ev, fld) ) continue;
- //we might have it!
- std::cout << ev;
- signature.clear();
- signature.resize (signature_size(), 0);
-
- for (i = 0; i < fld.n; ++i) if (ev[i]) {
- uint epos = support_pos[i];
- if (epos == fld.n) break; //bad luck, undecodable
- signature[epos] = 1;
- }
- if (i == fld.n) return 0;
- }
- return 1; //no attempts left.
-}
-
-int pubkey::verify (const bvector&signature, const bvector&hash, uint delta)
-{
- if (signature.size() != signature_size() ) return 2;
- if (hash.size() != hash_size() ) return 2;
-
- uint i, j;
- uint block_size = 1 << T;
- bvector synd, b1, b2;
-
- synd.resize (t * qd_sigs.size(), 0);
- //compute the syndrome
- for (i = 0; i < signature_size(); ++i) {
- if (!signature[i]) continue;
-
- //this is actually quite fast, as it happens only several times
- for (j = 0; j < qd_sigs.size(); ++j) {
- qd_sigs[j].get_block ( (i / block_size) *block_size,
- block_size, b1);
- permutation::permute_dyadic (i % block_size, b1, b2);
- b2.resize (t);
- synd.add_offset (b2, t * j);
- }
- }
-
- std::cout << "SYNDROME: " << synd;
- synd.add (hash);
- std::cout << "DIFF: " << synd;
- if (synd.hamming_weight() > delta) return 1;
-
- return 0;
-}
diff --git a/lib/mce_oc.cpp b/lib/mce_oc.cpp
deleted file mode 100644
index 56447ac..0000000
--- a/lib/mce_oc.cpp
+++ /dev/null
@@ -1,185 +0,0 @@
-
-/*
- * This file is part of Codecrypt.
- *
- * Codecrypt is free software: you can redistribute it and/or modify it
- * under the terms of the GNU Lesser General Public License as published by
- * the Free Software Foundation, either version 3 of the License, or (at
- * your option) any later version.
- *
- * Codecrypt is distributed in the hope that it will be useful, but WITHOUT
- * ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
- * FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public
- * License for more details.
- *
- * You should have received a copy of the GNU Lesser General Public License
- * along with Codecrypt. If not, see .
- */
-
-#include "codecrypt.h"
-
-using namespace ccr;
-using namespace ccr::mce_oc;
-
-#include "decoding.h"
-
-int mce_oc::generate (pubkey&pub, privkey&priv,
- prng&rng, uint m, uint t, uint n)
-{
- priv.fld.create (m);
-
- uint subplain_size = priv.fld.n - (m * t),
- codeword_size = (n * subplain_size) + (m * t);
-
- //prepare resulting generator matrix
- matrix g;
- g.resize (codeword_size);
- for (uint i = 0; i < codeword_size; ++i)
- g[i].resize (subplain_size * n);
-
- //generate n subcodes
- priv.codes.resize (n);
- for (uint i = 0; i < n; ++i) {
- privkey::subcode& sc = priv.codes[i];
-
- sc.g.generate_random_irreducible (t, priv.fld, rng);
- sc.g.compute_goppa_check_matrix (sc.h, priv.fld);
-
- matrix subg;
- while (!sc.h.create_goppa_generator (subg, sc.hperm, rng) );
- g.set_block (subplain_size * i, subplain_size * i, subg);
- }
-
- //scramble matrix
- matrix S;
- S.generate_random_with_inversion (g.height(), priv.Sinv, rng);
-
- //scramble permutation
- permutation P;
- P.generate_random (g.width(), rng);
- P.compute_inversion (priv.Pinv);
-
- //public key
- pub.n = n;
- pub.t = t;
- S.mult (g);
- P.permute (S, pub.G);
-
- return 0;
-}
-
-int privkey::prepare ()
-{
- for (uint i = 0; i < codes.size(); ++i) {
- codes[i].g.compute_goppa_check_matrix (codes[i].h, fld);
- codes[i].g.compute_square_root_matrix (codes[i].sqInv, fld);
- }
- return 0;
-}
-
-int privkey::sign (const bvector&in, bvector&out,
- uint delta, uint attempts, prng&rng)
-{
- if (in.size() != hash_size() ) return 2;
- if (!codes.size() ) return 2;
-
- //remove permutation
- bvector inp;
- Pinv.permute (in, inp);
-
- //decoding helpers
- bvector e, e2, synd, synd_orig, cw, cwc, plain, overlap;
- std::vector epos;
- permutation hpermInv;
- polynomial loc, Synd;
- uint i, t;
-
- uint mt = fld.m * codes[0].g.degree(),
- subplain_size = fld.n - mt;
-
- plain.clear();
-
- //decode the rest
- for (uint ci = 0; ci < codes.size(); ++ci) {
-
- e.clear();
- e.resize (fld.n, 0);
- epos.resize (delta, 0);
-
- //create the codeword
- cw.clear();
- if (ci == 0)
- cw.insert (cw.end(), inp.begin(), inp.begin() + fld.n);
- else {
- cw = overlap;
- bvector::iterator tmp = inp.begin();
- tmp += (ci * subplain_size) + mt;
- cw.insert (cw.end(), tmp, tmp + subplain_size);
- }
-
- //create the overlap, xor it to codeword
- if (ci + 1 < codes.size() ) {
- overlap.resize (mt);
- for (uint i = 0; i < mt; ++i) overlap[i] = rng.random (2);
- cw.add_offset (overlap, subplain_size);
- }
-
- //compute syndrome with no extra errors
- codes[ci].hperm.compute_inversion (hpermInv);
- hpermInv.permute (cw, cwc); //canonical
- codes[ci].h.mult_vec_right (cwc, synd_orig);
-
- for (t = 0; t < attempts; ++t) {
-
- //compute syndrome with extra errors
- synd = synd_orig;
- for (i = 0; i < delta; ++i) {
- epos[i] = rng.random (fld.n);
- if (!e[epos[i]])
- synd.add (codes[ci].h[epos[i]]);
- e[epos[i]] = 1;
- }
-
- synd.to_poly (Synd, fld);
- compute_goppa_error_locator (Synd, fld,
- codes[ci].g,
- codes[ci].sqInv, loc);
-
- if (evaluate_error_locator_trace (loc, e2, fld) ) {
- cwc.add (e);
- cwc.add (e2);
-
- codes[ci].hperm.permute (cwc, cw);
- plain.insert (plain.end(), cw.begin(),
- cw.begin() +
- (fld.n - (fld.m *
- codes[ci].g.degree() ) )
- );
- break;
- }
-
- for (i = 0; i < delta; ++i) {
- e[epos[i]] = 0;
- }
- }
-
- if (t >= attempts) //decoding failed
- return 1;
-
- }
-
- Sinv.mult_vecT_left (plain, out);
-
- return 0;
-}
-
-int pubkey::verify (const bvector&in, const bvector&hash, uint delta)
-{
- bvector tmp;
- if (!G.mult_vecT_left (in, tmp) ) return 2; //sizing problem
- if (hash.size() != tmp.size() ) return 1; //invalid hash size
-
- tmp.add (hash);
- if (tmp.hamming_weight() > n * (t + delta) ) return 1; //too far
- return 0;
-}
diff --git a/lib/bvector.cpp b/src/bvector.cpp
similarity index 99%
rename from lib/bvector.cpp
rename to src/bvector.cpp
index 1f35a3c..3c2cf35 100644
--- a/lib/bvector.cpp
+++ b/src/bvector.cpp
@@ -17,7 +17,6 @@
*/
#include "codecrypt.h"
-using namespace ccr;
uint bvector::hamming_weight()
{
diff --git a/include/codecrypt.h b/src/codecrypt.h
similarity index 79%
rename from include/codecrypt.h
rename to src/codecrypt.h
index a70cd72..e14beea 100644
--- a/include/codecrypt.h
+++ b/src/codecrypt.h
@@ -36,9 +36,6 @@
item(size_type n, size_type m) const \
{ return (*this)[n][m]; };
-namespace ccr
-{
-
/*
* data serialization format
*/
@@ -552,157 +549,14 @@ public:
int generate (pubkey&, privkey&, prng&, uint m, uint T, uint b);
}
-/*
- * QD-CFS
- *
- * according to "Quasi-dyadic CFS signatures" by Baretto, Cayrel, Misoczki,
- * Niebuhr.
- *
- * As always with Niederreiter, hash must be of weight t (=1< essence;
- gf2m fld; //we fix q=2^fld.m=fld.n, n=q/2
- uint T, t; //size of blocks is 1< block_perms; //dyadic permutations of blocks
-
- //derivable stuff
- polynomial g; //goppa
- std::vector sqInv; //sqroot mod g
- //pre-permuted positions of support rows
- std::vector support_pos;
- std::vector syndS;
-
- int sign (const bvector&, bvector&, uint d, uint attempts, prng&);
- int prepare();
-
- uint hash_size() {
- return t * fld.m;
- }
- uint signature_size() {
- return (1 << T) * block_perms.size();
- }
- uint signature_weight() {
- return t;
- }
-
- sencode* serialize();
- bool unserialize (sencode*);
-};
-
-class pubkey
-{
-public:
- uint t, T;
- //cols of H
- std::vector qd_sigs;
-
- int verify (const bvector&, const bvector&, uint);
-
- uint hash_size() {
- return t * qd_sigs.size();
- }
- uint signature_size() {
- return qd_sigs[0].size();
- }
- uint signature_weight() {
- return t;
- }
-
- sencode* serialize();
- bool unserialize (sencode*);
-};
-
-int generate (pubkey&, privkey&, prng&, uint m, uint T, uint t, uint b);
-}
-
-/*
- * McEliece on Overlapping Chain of Goppa Codes
- *
- * Similar to Hamdi's Chained BCH Codes, but with improvements.
- *
- * This is experimental, unverified, probably insecure, but practical scheme
- * that achieves good speed, probability and non-exponential key size for full
- * decoding that is needed to produce signatures. Technique is described in
- * documentation, with some (probably sufficient) notes in source code.
- *
- * Note that encryption using this scheme is impossible, as there is only an
- * extremely tiny probability of successful decoding.
- */
-namespace mce_oc
-{
-class privkey
-{
-public:
- matrix Sinv;
- permutation Pinv;
- gf2m fld;
-
- class subcode
- {
- public:
- polynomial g;
- permutation hperm;
-
- //derivables
- matrix h;
- std::vector sqInv;
- };
-
- std::vector codes;
-
- int sign (const bvector&, bvector&, uint, uint, prng&);
- int prepare();
-
- uint hash_size() {
- return Pinv.size();
- }
- uint signature_size() {
- return Sinv.size();
- }
-
- sencode* serialize();
- bool unserialize (sencode*);
-};
-
-class pubkey
-{
-public:
- matrix G;
- uint n, t;
-
- int verify (const bvector&, const bvector&, uint);
-
- uint hash_size() {
- return G.width();
- }
- uint signature_size() {
- return G.height();
- }
-
- sencode* serialize();
- bool unserialize (sencode*);
-};
-
-//n is the number of subcodes used
-int generate (pubkey&, privkey&, prng&, uint m, uint t, uint n);
-}
-
-} //namespace ccr
-
//global overload for iostream operators
#include
-std::ostream& operator<< (std::ostream&o, const ccr::polynomial&);
-std::ostream& operator<< (std::ostream&o, const ccr::permutation&);
-std::ostream& operator<< (std::ostream&o, const ccr::gf2m&);
-std::ostream& operator<< (std::ostream&o, const ccr::matrix&);
-std::ostream& operator<< (std::ostream&o, const ccr::bvector&);
+std::ostream& operator<< (std::ostream&o, const polynomial&);
+std::ostream& operator<< (std::ostream&o, const permutation&);
+std::ostream& operator<< (std::ostream&o, const gf2m&);
+std::ostream& operator<< (std::ostream&o, const matrix&);
+std::ostream& operator<< (std::ostream&o, const bvector&);
#endif // _CODECRYPT_H_
diff --git a/lib/decoding.cpp b/src/decoding.cpp
similarity index 100%
rename from lib/decoding.cpp
rename to src/decoding.cpp
diff --git a/lib/decoding.h b/src/decoding.h
similarity index 98%
rename from lib/decoding.h
rename to src/decoding.h
index 11ea34e..8fac308 100644
--- a/lib/decoding.h
+++ b/src/decoding.h
@@ -21,8 +21,6 @@
#include "codecrypt.h"
-using namespace ccr;
-
void compute_goppa_error_locator (polynomial&syndrome,
gf2m&fld,
polynomial&goppa,
diff --git a/src/encryption.h b/src/encryption.h
new file mode 100644
index 0000000..baef1e4
--- /dev/null
+++ b/src/encryption.h
@@ -0,0 +1,25 @@
+
+
+/*
+ * This file is part of Codecrypt.
+ *
+ * Codecrypt is free software: you can redistribute it and/or modify it
+ * under the terms of the GNU Lesser General Public License as published by
+ * the Free Software Foundation, either version 3 of the License, or (at
+ * your option) any later version.
+ *
+ * Codecrypt is distributed in the hope that it will be useful, but WITHOUT
+ * ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+ * FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public
+ * License for more details.
+ *
+ * You should have received a copy of the GNU Lesser General Public License
+ * along with Codecrypt. If not, see .
+ */
+
+#ifndef _ccr_hash_h_
+#define _ccr_hash_h_
+
+
+#endif
+
diff --git a/lib/gf2m.cpp b/src/gf2m.cpp
similarity index 99%
rename from lib/gf2m.cpp
rename to src/gf2m.cpp
index 765e8dd..d23e381 100644
--- a/lib/gf2m.cpp
+++ b/src/gf2m.cpp
@@ -18,8 +18,6 @@
#include "codecrypt.h"
-using namespace ccr;
-
/*
* helpful stuff for arithmetic in GF(2^m) - polynomials over GF(2).
*/
diff --git a/src/hash.h b/src/hash.h
new file mode 100644
index 0000000..dad053a
--- /dev/null
+++ b/src/hash.h
@@ -0,0 +1,46 @@
+
+/*
+ * This file is part of Codecrypt.
+ *
+ * Codecrypt is free software: you can redistribute it and/or modify it
+ * under the terms of the GNU Lesser General Public License as published by
+ * the Free Software Foundation, either version 3 of the License, or (at
+ * your option) any later version.
+ *
+ * Codecrypt is distributed in the hope that it will be useful, but WITHOUT
+ * ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+ * FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public
+ * License for more details.
+ *
+ * You should have received a copy of the GNU Lesser General Public License
+ * along with Codecrypt. If not, see .
+ */
+
+#ifndef _ccr_hash_h_
+#define _ccr_hash_h_
+
+/*
+ * hash function templates
+ *
+ * usuable mostly for injection into actual code
+ */
+
+class hash {
+public:
+ hash();
+ virtual ~hash()=0;
+
+ virtual void init()=0;
+ virtual void update(const char*a, size_t len)=0;
+ virtual size_t size()=0;
+ virtual void final(const char*a)=0;
+};
+
+class hash_factory {
+public:
+ hash* create();
+ void free(hash*);
+};
+
+#endif
+
diff --git a/lib/ios.cpp b/src/ios.cpp
similarity index 98%
rename from lib/ios.cpp
rename to src/ios.cpp
index 8e85135..0557fae 100644
--- a/lib/ios.cpp
+++ b/src/ios.cpp
@@ -20,7 +20,6 @@
#include
using namespace std;
-using namespace ccr;
ostream& operator<< (ostream&o, const polynomial& p)
{
diff --git a/src/keymgmt.h b/src/keymgmt.h
new file mode 100644
index 0000000..e00d293
--- /dev/null
+++ b/src/keymgmt.h
@@ -0,0 +1,23 @@
+
+/*
+ * This file is part of Codecrypt.
+ *
+ * Codecrypt is free software: you can redistribute it and/or modify it
+ * under the terms of the GNU Lesser General Public License as published by
+ * the Free Software Foundation, either version 3 of the License, or (at
+ * your option) any later version.
+ *
+ * Codecrypt is distributed in the hope that it will be useful, but WITHOUT
+ * ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+ * FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public
+ * License for more details.
+ *
+ * You should have received a copy of the GNU Lesser General Public License
+ * along with Codecrypt. If not, see .
+ */
+
+#ifndef _ccr_keys_h_
+#define _ccr_keys_h_
+
+#endif
+
diff --git a/src/main.cpp b/src/main.cpp
index dddc035..c932600 100644
--- a/src/main.cpp
+++ b/src/main.cpp
@@ -17,14 +17,16 @@
*/
#include "codecrypt.h"
+#include "arcfour.h"
#include
#include
#include
+#include
using namespace std;
-class primitiverng : public ccr::prng
+class primitiverng : public prng
{
public:
uint random (uint n) {
@@ -38,20 +40,150 @@ public:
int main()
{
+ arcfour c;
+ if (!c.init (10) ) {
+ cout << "haha." << endl;
+ return 1;
+ }
+ std::vector k;
+ k.push_back ('K');
+ k.push_back ('e');
+ k.push_back ('y');
+ k.push_back ('l');
+ k.push_back ('o');
+ k.push_back ('l');
+ c.load_key (k);
+
+ for (int i = 0; i < 20; ++i)
+ cout << hex << (int) c.gen() << endl;
+
+ return 0;
+
+#if 0
+ primitiverng r;
+ r.seed (0);
+
+ mce::pubkey pub, pub2;
+ mce::privkey priv, priv2;
+ mce::generate (pub, priv, r, 6, 2);
+
+ sencode *s;
+ std::cout << priv.Pinv;
+ s = priv.serialize();
+ std::cout << s->encode();
+ if (priv.unserialize (s) )
+ std::cout << priv.Pinv;
+
+ sencode_destroy (s);
+ return 0;
+ sencode_list*x = new sencode_list;
+ x->items.push_back (new sencode_int (1) );
+ x->items.push_back (new sencode_bytes ("ahoj") );
+ std::string tmp = x->encode();
+ std::cout << tmp << std::endl;
+ sencode_destroy (x);
+ sencode*s;
+ sencode_decode (tmp, &s);
+ std::cout << s->encode() << std::endl;
+ sencode_destroy (s);
+ bvector b;
+ b.resize (9);
+ b[0] = 1;
+ b[5] = 1;
+ b[8] = 1;
+ s = b.serialize();
+ b[6] = 1;
+ std::cout << s->encode() << std::endl;
+ if (b.unserialize (s) ) {
+ std::cout << b ;
+ }
+ sencode_destroy (s);
+ return 0;
/* this is just a test, don't mind it */
primitiverng r;
r.seed (0);
- ccr::mce_qd::privkey priv;
- ccr::mce_qd::pubkey pub;
- ccr::mce_qd::generate (pub, priv, r, 14, 8, 2);
+ /*
+ mce::privkey priv;
+ mce::pubkey pub;
+ mce::generate(pub,priv,r,8,7);
- cout << "cipher size: " << priv.cipher_size() << ' ' << pub.cipher_size() << endl;
- cout << "plain size: " << priv.plain_size() << ' ' << pub.plain_size() << endl;
+ bvector a,b;
+
+ a.resize(priv.hash_size(),0);
+
+ a[0]=1;
+ a[2]=1;
+ a[4]=1;
+ a[5]=1;
+ a[6]=1;
+ a[7]=1;
+ a[10]=1;
+ a[12]=1;
+ a[16]=1;
+ a[20]=1;
+ a[22]=1;
+ a[24]=1;
+ a[25]=1;
+ a[26]=1;
+ a[27]=1;
+ a[110]=1;
+ a[112]=1;
+ a[116]=1;
+ priv.prepare();
+ priv.sign(a,b,3,10000,r);
+ std::cout << a << b << pub.verify(b,a,3) << std::endl;
+ */
+ cfs_qd::privkey priv;
+ cfs_qd::pubkey pub;
+ cfs_qd::generate (pub, priv, r, 7, 3, 7, 1);
+
+ cout << "hash size: " << priv.hash_size() << ' ' << pub.hash_size() << endl;
+ cout << "signature size: " << priv.signature_size() << ' ' << pub.signature_size() << endl;
+
+ cout << "sig weight: " << priv.signature_weight() << ' ' << pub.signature_weight() << endl;
priv.prepare();
- ccr::bvector plain;
+ bvector hash;
+ hash.resize (priv.hash_size(), 0);
+ hash[0] = 1;
+ hash[2] = 1;
+ hash[4] = 1;
+ hash[5] = 1;
+ hash[6] = 1;
+ hash[7] = 1;
+ hash[10] = 1;
+ hash[12] = 1;
+ hash[16] = 1;
+ hash[20] = 1;
+ hash[22] = 1;
+ hash[24] = 1;
+ hash[25] = 1;
+ hash[26] = 1;
+ hash[27] = 1;
+ hash[110] = 1;
+ hash[112] = 1;
+ hash[116] = 1;
+
+ cout << "HASH " << endl;
+ cout << hash;
+
+ bvector sig;
+ if (priv.sign (hash, sig, 3, 10000, r) ) {
+ cout << "failed" << endl;
+ return 0;
+ }
+
+ cout << "SIGNATURE " << sig;
+
+ if (pub.verify (sig, hash, 3) )
+ cout << "verify failed" << endl;
+ else cout << "verify okay" << endl;
+
+#endif
+#if 0
+ bvector plain;
plain.resize (pub.plain_size(), 0);
plain[0] = 1;
plain[1] = 1;
@@ -60,18 +192,19 @@ int main()
cout << "PLAINTEXT" << endl;
cout << plain;
- ccr::bvector cipher;
+ bvector cipher;
pub.encrypt (plain, cipher, r);
cout << "CIPHERTEXT" << endl;
cout << cipher;
- ccr::bvector decrypted;
+ bvector decrypted;
priv.decrypt (cipher, decrypted);
cout << "DECRYPTED" << endl;
cout << decrypted;
+#endif
return 0;
}
diff --git a/lib/matrix.cpp b/src/matrix.cpp
similarity index 99%
rename from lib/matrix.cpp
rename to src/matrix.cpp
index 24095a9..dfde4ae 100644
--- a/lib/matrix.cpp
+++ b/src/matrix.cpp
@@ -18,8 +18,6 @@
#include "codecrypt.h"
-using namespace ccr;
-
void matrix::resize2 (uint w, uint h, bool def)
{
resize (w);
diff --git a/lib/mce.cpp b/src/mce.cpp
similarity index 99%
rename from lib/mce.cpp
rename to src/mce.cpp
index 64c8cf6..4cafb4f 100644
--- a/lib/mce.cpp
+++ b/src/mce.cpp
@@ -18,8 +18,7 @@
#include "codecrypt.h"
-using namespace ccr;
-using namespace ccr::mce;
+using namespace mce;
#include "decoding.h"
diff --git a/lib/mce_qd.cpp b/src/mce_qd.cpp
similarity index 99%
rename from lib/mce_qd.cpp
rename to src/mce_qd.cpp
index e0c6014..7189324 100644
--- a/lib/mce_qd.cpp
+++ b/src/mce_qd.cpp
@@ -18,8 +18,7 @@
#include "codecrypt.h"
-using namespace ccr;
-using namespace ccr::mce_qd;
+using namespace mce_qd;
#include "decoding.h"
#include "qd_utils.h"
diff --git a/src/message.h b/src/message.h
new file mode 100644
index 0000000..e9617fa
--- /dev/null
+++ b/src/message.h
@@ -0,0 +1,23 @@
+
+/*
+ * This file is part of Codecrypt.
+ *
+ * Codecrypt is free software: you can redistribute it and/or modify it
+ * under the terms of the GNU Lesser General Public License as published by
+ * the Free Software Foundation, either version 3 of the License, or (at
+ * your option) any later version.
+ *
+ * Codecrypt is distributed in the hope that it will be useful, but WITHOUT
+ * ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+ * FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public
+ * License for more details.
+ *
+ * You should have received a copy of the GNU Lesser General Public License
+ * along with Codecrypt. If not, see .
+ */
+
+#ifndef _ccr_msg_h_
+#define _ccr_msg_h_
+
+#endif
+
diff --git a/lib/nd.cpp b/src/nd.cpp
similarity index 98%
rename from lib/nd.cpp
rename to src/nd.cpp
index 3bbe11c..10e8491 100644
--- a/lib/nd.cpp
+++ b/src/nd.cpp
@@ -18,10 +18,9 @@
#include "codecrypt.h"
-#include "decoding.h"
+using namespace nd;
-using namespace ccr;
-using namespace ccr::nd;
+#include "decoding.h"
int nd::generate (pubkey&pub, privkey&priv, prng&rng, uint m, uint t)
{
diff --git a/lib/permutation.cpp b/src/permutation.cpp
similarity index 98%
rename from lib/permutation.cpp
rename to src/permutation.cpp
index 16abf7d..148cc89 100644
--- a/lib/permutation.cpp
+++ b/src/permutation.cpp
@@ -18,8 +18,6 @@
#include "codecrypt.h"
-using namespace ccr;
-
void permutation::compute_inversion (permutation&r) const
{
r.resize (size(), 0);
diff --git a/lib/polynomial.cpp b/src/polynomial.cpp
similarity index 99%
rename from lib/polynomial.cpp
rename to src/polynomial.cpp
index 19070b0..1048222 100644
--- a/lib/polynomial.cpp
+++ b/src/polynomial.cpp
@@ -18,8 +18,6 @@
#include "codecrypt.h"
-using namespace ccr;
-
int polynomial::degree() const
{
int r = -1;
diff --git a/lib/qd_utils.cpp b/src/qd_utils.cpp
similarity index 100%
rename from lib/qd_utils.cpp
rename to src/qd_utils.cpp
diff --git a/lib/qd_utils.h b/src/qd_utils.h
similarity index 98%
rename from lib/qd_utils.h
rename to src/qd_utils.h
index cd79006..2b752df 100644
--- a/lib/qd_utils.h
+++ b/src/qd_utils.h
@@ -22,8 +22,6 @@
#include "codecrypt.h"
#include
-using namespace ccr;
-
//FWHT matrix mult in O(n log n). parameters MUST be of 2^m size.
void fwht_dyadic_multiply (const bvector&, const bvector&, bvector&);
diff --git a/lib/sencode.cpp b/src/sencode.cpp
similarity index 96%
rename from lib/sencode.cpp
rename to src/sencode.cpp
index 47e1df5..b5b5e32 100644
--- a/lib/sencode.cpp
+++ b/src/sencode.cpp
@@ -17,7 +17,6 @@
*/
#include "codecrypt.h"
-using namespace ccr;
#include
#include
@@ -66,7 +65,7 @@ fail:
pos = -1;
}
-bool ccr::sencode_decode (const std::string& str, sencode**out)
+bool sencode_decode (const std::string& str, sencode**out)
{
std::list stk;
int pos = 0;
@@ -125,7 +124,7 @@ bool ccr::sencode_decode (const std::string& str, sencode**out)
return false;
}
-void ccr::sencode_destroy (sencode*x)
+void sencode_destroy (sencode*x)
{
x->destroy();
delete x;
diff --git a/lib/serialization.cpp b/src/serialization.cpp
similarity index 94%
rename from lib/serialization.cpp
rename to src/serialization.cpp
index 54dc5d5..42fb6ff 100644
--- a/lib/serialization.cpp
+++ b/src/serialization.cpp
@@ -18,8 +18,6 @@
#include "codecrypt.h"
-using namespace ccr;
-
static sencode* serialize_uint_vector (std::vector*v)
{
sencode_list*l = new sencode_list;
@@ -299,43 +297,3 @@ bool mce_qd::pubkey::unserialize (sencode* s)
return true;
}
-sencode* cfs_qd::privkey::serialize()
-{
-
-}
-
-bool cfs_qd::privkey::unserialize (sencode* s)
-{
-
-}
-
-sencode* cfs_qd::pubkey::serialize()
-{
-
-}
-
-bool cfs_qd::pubkey::unserialize (sencode* s)
-{
-
-}
-
-sencode* mce_oc::privkey::serialize()
-{
-
-}
-
-bool mce_oc::privkey::unserialize (sencode* s)
-{
-
-}
-
-sencode* mce_oc::pubkey::serialize()
-{
-
-}
-
-bool mce_oc::pubkey::unserialize (sencode* s)
-{
-
-}
-
diff --git a/src/sha2.c b/src/sha2.c
new file mode 100644
index 0000000..810eb83
--- /dev/null
+++ b/src/sha2.c
@@ -0,0 +1,1065 @@
+/*
+ * FILE: sha2.c
+ * AUTHOR: Aaron D. Gifford - http://www.aarongifford.com/
+ *
+ * Copyright (c) 2000-2001, Aaron D. Gifford
+ * All rights reserved.
+ *
+ * Redistribution and use in source and binary forms, with or without
+ * modification, are permitted provided that the following conditions
+ * are met:
+ * 1. Redistributions of source code must retain the above copyright
+ * notice, this list of conditions and the following disclaimer.
+ * 2. Redistributions in binary form must reproduce the above copyright
+ * notice, this list of conditions and the following disclaimer in the
+ * documentation and/or other materials provided with the distribution.
+ * 3. Neither the name of the copyright holder nor the names of contributors
+ * may be used to endorse or promote products derived from this software
+ * without specific prior written permission.
+ *
+ * THIS SOFTWARE IS PROVIDED BY THE AUTHOR AND CONTRIBUTOR(S) ``AS IS'' AND
+ * ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
+ * IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE
+ * ARE DISCLAIMED. IN NO EVENT SHALL THE AUTHOR OR CONTRIBUTOR(S) BE LIABLE
+ * FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL
+ * DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS
+ * OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION)
+ * HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT
+ * LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY
+ * OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF
+ * SUCH DAMAGE.
+ *
+ * $Id: sha2.c,v 1.1 2001/11/08 00:01:51 adg Exp adg $
+ */
+
+#include /* memcpy()/memset() or bcopy()/bzero() */
+#include /* assert() */
+#include "sha2.h"
+
+/*
+ * ASSERT NOTE:
+ * Some sanity checking code is included using assert(). On my FreeBSD
+ * system, this additional code can be removed by compiling with NDEBUG
+ * defined. Check your own systems manpage on assert() to see how to
+ * compile WITHOUT the sanity checking code on your system.
+ *
+ * UNROLLED TRANSFORM LOOP NOTE:
+ * You can define SHA2_UNROLL_TRANSFORM to use the unrolled transform
+ * loop version for the hash transform rounds (defined using macros
+ * later in this file). Either define on the command line, for example:
+ *
+ * cc -DSHA2_UNROLL_TRANSFORM -o sha2 sha2.c sha2prog.c
+ *
+ * or define below:
+ *
+ * #define SHA2_UNROLL_TRANSFORM
+ *
+ */
+
+
+/*** SHA-256/384/512 Machine Architecture Definitions *****************/
+/*
+ * BYTE_ORDER NOTE:
+ *
+ * Please make sure that your system defines BYTE_ORDER. If your
+ * architecture is little-endian, make sure it also defines
+ * LITTLE_ENDIAN and that the two (BYTE_ORDER and LITTLE_ENDIAN) are
+ * equivilent.
+ *
+ * If your system does not define the above, then you can do so by
+ * hand like this:
+ *
+ * #define LITTLE_ENDIAN 1234
+ * #define BIG_ENDIAN 4321
+ *
+ * And for little-endian machines, add:
+ *
+ * #define BYTE_ORDER LITTLE_ENDIAN
+ *
+ * Or for big-endian machines:
+ *
+ * #define BYTE_ORDER BIG_ENDIAN
+ *
+ * The FreeBSD machine this was written on defines BYTE_ORDER
+ * appropriately by including (which in turn includes
+ * where the appropriate definitions are actually
+ * made).
+ */
+#if !defined(BYTE_ORDER) || (BYTE_ORDER != LITTLE_ENDIAN && BYTE_ORDER != BIG_ENDIAN)
+#error Define BYTE_ORDER to be equal to either LITTLE_ENDIAN or BIG_ENDIAN
+#endif
+
+/*
+ * Define the followingsha2_* types to types of the correct length on
+ * the native archtecture. Most BSD systems and Linux define u_intXX_t
+ * types. Machines with very recent ANSI C headers, can use the
+ * uintXX_t definintions from inttypes.h by defining SHA2_USE_INTTYPES_H
+ * during compile or in the sha.h header file.
+ *
+ * Machines that support neither u_intXX_t nor inttypes.h's uintXX_t
+ * will need to define these three typedefs below (and the appropriate
+ * ones in sha.h too) by hand according to their system architecture.
+ *
+ * Thank you, Jun-ichiro itojun Hagino, for suggesting using u_intXX_t
+ * types and pointing out recent ANSI C support for uintXX_t in inttypes.h.
+ */
+#ifdef SHA2_USE_INTTYPES_H
+
+typedef uint8_t sha2_byte; /* Exactly 1 byte */
+typedef uint32_t sha2_word32; /* Exactly 4 bytes */
+typedef uint64_t sha2_word64; /* Exactly 8 bytes */
+
+#else /* SHA2_USE_INTTYPES_H */
+
+typedef u_int8_t sha2_byte; /* Exactly 1 byte */
+typedef u_int32_t sha2_word32; /* Exactly 4 bytes */
+typedef u_int64_t sha2_word64; /* Exactly 8 bytes */
+
+#endif /* SHA2_USE_INTTYPES_H */
+
+
+/*** SHA-256/384/512 Various Length Definitions ***********************/
+/* NOTE: Most of these are in sha2.h */
+#define SHA256_SHORT_BLOCK_LENGTH (SHA256_BLOCK_LENGTH - 8)
+#define SHA384_SHORT_BLOCK_LENGTH (SHA384_BLOCK_LENGTH - 16)
+#define SHA512_SHORT_BLOCK_LENGTH (SHA512_BLOCK_LENGTH - 16)
+
+
+/*** ENDIAN REVERSAL MACROS *******************************************/
+#if BYTE_ORDER == LITTLE_ENDIAN
+#define REVERSE32(w,x) { \
+ sha2_word32 tmp = (w); \
+ tmp = (tmp >> 16) | (tmp << 16); \
+ (x) = ((tmp & 0xff00ff00UL) >> 8) | ((tmp & 0x00ff00ffUL) << 8); \
+}
+#define REVERSE64(w,x) { \
+ sha2_word64 tmp = (w); \
+ tmp = (tmp >> 32) | (tmp << 32); \
+ tmp = ((tmp & 0xff00ff00ff00ff00ULL) >> 8) | \
+ ((tmp & 0x00ff00ff00ff00ffULL) << 8); \
+ (x) = ((tmp & 0xffff0000ffff0000ULL) >> 16) | \
+ ((tmp & 0x0000ffff0000ffffULL) << 16); \
+}
+#endif /* BYTE_ORDER == LITTLE_ENDIAN */
+
+/*
+ * Macro for incrementally adding the unsigned 64-bit integer n to the
+ * unsigned 128-bit integer (represented using a two-element array of
+ * 64-bit words):
+ */
+#define ADDINC128(w,n) { \
+ (w)[0] += (sha2_word64)(n); \
+ if ((w)[0] < (n)) { \
+ (w)[1]++; \
+ } \
+}
+
+/*
+ * Macros for copying blocks of memory and for zeroing out ranges
+ * of memory. Using these macros makes it easy to switch from
+ * using memset()/memcpy() and using bzero()/bcopy().
+ *
+ * Please define either SHA2_USE_MEMSET_MEMCPY or define
+ * SHA2_USE_BZERO_BCOPY depending on which function set you
+ * choose to use:
+ */
+#if !defined(SHA2_USE_MEMSET_MEMCPY) && !defined(SHA2_USE_BZERO_BCOPY)
+/* Default to memset()/memcpy() if no option is specified */
+#define SHA2_USE_MEMSET_MEMCPY 1
+#endif
+#if defined(SHA2_USE_MEMSET_MEMCPY) && defined(SHA2_USE_BZERO_BCOPY)
+/* Abort with an error if BOTH options are defined */
+#error Define either SHA2_USE_MEMSET_MEMCPY or SHA2_USE_BZERO_BCOPY, not both!
+#endif
+
+#ifdef SHA2_USE_MEMSET_MEMCPY
+#define MEMSET_BZERO(p,l) memset((p), 0, (l))
+#define MEMCPY_BCOPY(d,s,l) memcpy((d), (s), (l))
+#endif
+#ifdef SHA2_USE_BZERO_BCOPY
+#define MEMSET_BZERO(p,l) bzero((p), (l))
+#define MEMCPY_BCOPY(d,s,l) bcopy((s), (d), (l))
+#endif
+
+
+/*** THE SIX LOGICAL FUNCTIONS ****************************************/
+/*
+ * Bit shifting and rotation (used by the six SHA-XYZ logical functions:
+ *
+ * NOTE: The naming of R and S appears backwards here (R is a SHIFT and
+ * S is a ROTATION) because the SHA-256/384/512 description document
+ * (see http://csrc.nist.gov/cryptval/shs/sha256-384-512.pdf) uses this
+ * same "backwards" definition.
+ */
+/* Shift-right (used in SHA-256, SHA-384, and SHA-512): */
+#define R(b,x) ((x) >> (b))
+/* 32-bit Rotate-right (used in SHA-256): */
+#define S32(b,x) (((x) >> (b)) | ((x) << (32 - (b))))
+/* 64-bit Rotate-right (used in SHA-384 and SHA-512): */
+#define S64(b,x) (((x) >> (b)) | ((x) << (64 - (b))))
+
+/* Two of six logical functions used in SHA-256, SHA-384, and SHA-512: */
+#define Ch(x,y,z) (((x) & (y)) ^ ((~(x)) & (z)))
+#define Maj(x,y,z) (((x) & (y)) ^ ((x) & (z)) ^ ((y) & (z)))
+
+/* Four of six logical functions used in SHA-256: */
+#define Sigma0_256(x) (S32(2, (x)) ^ S32(13, (x)) ^ S32(22, (x)))
+#define Sigma1_256(x) (S32(6, (x)) ^ S32(11, (x)) ^ S32(25, (x)))
+#define sigma0_256(x) (S32(7, (x)) ^ S32(18, (x)) ^ R(3 , (x)))
+#define sigma1_256(x) (S32(17, (x)) ^ S32(19, (x)) ^ R(10, (x)))
+
+/* Four of six logical functions used in SHA-384 and SHA-512: */
+#define Sigma0_512(x) (S64(28, (x)) ^ S64(34, (x)) ^ S64(39, (x)))
+#define Sigma1_512(x) (S64(14, (x)) ^ S64(18, (x)) ^ S64(41, (x)))
+#define sigma0_512(x) (S64( 1, (x)) ^ S64( 8, (x)) ^ R( 7, (x)))
+#define sigma1_512(x) (S64(19, (x)) ^ S64(61, (x)) ^ R( 6, (x)))
+
+/*** INTERNAL FUNCTION PROTOTYPES *************************************/
+/* NOTE: These should not be accessed directly from outside this
+ * library -- they are intended for private internal visibility/use
+ * only.
+ */
+void SHA512_Last(SHA512_CTX*);
+void SHA256_Transform(SHA256_CTX*, const sha2_word32*);
+void SHA512_Transform(SHA512_CTX*, const sha2_word64*);
+
+
+/*** SHA-XYZ INITIAL HASH VALUES AND CONSTANTS ************************/
+/* Hash constant words K for SHA-256: */
+const static sha2_word32 K256[64] = {
+ 0x428a2f98UL, 0x71374491UL, 0xb5c0fbcfUL, 0xe9b5dba5UL,
+ 0x3956c25bUL, 0x59f111f1UL, 0x923f82a4UL, 0xab1c5ed5UL,
+ 0xd807aa98UL, 0x12835b01UL, 0x243185beUL, 0x550c7dc3UL,
+ 0x72be5d74UL, 0x80deb1feUL, 0x9bdc06a7UL, 0xc19bf174UL,
+ 0xe49b69c1UL, 0xefbe4786UL, 0x0fc19dc6UL, 0x240ca1ccUL,
+ 0x2de92c6fUL, 0x4a7484aaUL, 0x5cb0a9dcUL, 0x76f988daUL,
+ 0x983e5152UL, 0xa831c66dUL, 0xb00327c8UL, 0xbf597fc7UL,
+ 0xc6e00bf3UL, 0xd5a79147UL, 0x06ca6351UL, 0x14292967UL,
+ 0x27b70a85UL, 0x2e1b2138UL, 0x4d2c6dfcUL, 0x53380d13UL,
+ 0x650a7354UL, 0x766a0abbUL, 0x81c2c92eUL, 0x92722c85UL,
+ 0xa2bfe8a1UL, 0xa81a664bUL, 0xc24b8b70UL, 0xc76c51a3UL,
+ 0xd192e819UL, 0xd6990624UL, 0xf40e3585UL, 0x106aa070UL,
+ 0x19a4c116UL, 0x1e376c08UL, 0x2748774cUL, 0x34b0bcb5UL,
+ 0x391c0cb3UL, 0x4ed8aa4aUL, 0x5b9cca4fUL, 0x682e6ff3UL,
+ 0x748f82eeUL, 0x78a5636fUL, 0x84c87814UL, 0x8cc70208UL,
+ 0x90befffaUL, 0xa4506cebUL, 0xbef9a3f7UL, 0xc67178f2UL
+};
+
+/* Initial hash value H for SHA-256: */
+const static sha2_word32 sha256_initial_hash_value[8] = {
+ 0x6a09e667UL,
+ 0xbb67ae85UL,
+ 0x3c6ef372UL,
+ 0xa54ff53aUL,
+ 0x510e527fUL,
+ 0x9b05688cUL,
+ 0x1f83d9abUL,
+ 0x5be0cd19UL
+};
+
+/* Hash constant words K for SHA-384 and SHA-512: */
+const static sha2_word64 K512[80] = {
+ 0x428a2f98d728ae22ULL, 0x7137449123ef65cdULL,
+ 0xb5c0fbcfec4d3b2fULL, 0xe9b5dba58189dbbcULL,
+ 0x3956c25bf348b538ULL, 0x59f111f1b605d019ULL,
+ 0x923f82a4af194f9bULL, 0xab1c5ed5da6d8118ULL,
+ 0xd807aa98a3030242ULL, 0x12835b0145706fbeULL,
+ 0x243185be4ee4b28cULL, 0x550c7dc3d5ffb4e2ULL,
+ 0x72be5d74f27b896fULL, 0x80deb1fe3b1696b1ULL,
+ 0x9bdc06a725c71235ULL, 0xc19bf174cf692694ULL,
+ 0xe49b69c19ef14ad2ULL, 0xefbe4786384f25e3ULL,
+ 0x0fc19dc68b8cd5b5ULL, 0x240ca1cc77ac9c65ULL,
+ 0x2de92c6f592b0275ULL, 0x4a7484aa6ea6e483ULL,
+ 0x5cb0a9dcbd41fbd4ULL, 0x76f988da831153b5ULL,
+ 0x983e5152ee66dfabULL, 0xa831c66d2db43210ULL,
+ 0xb00327c898fb213fULL, 0xbf597fc7beef0ee4ULL,
+ 0xc6e00bf33da88fc2ULL, 0xd5a79147930aa725ULL,
+ 0x06ca6351e003826fULL, 0x142929670a0e6e70ULL,
+ 0x27b70a8546d22ffcULL, 0x2e1b21385c26c926ULL,
+ 0x4d2c6dfc5ac42aedULL, 0x53380d139d95b3dfULL,
+ 0x650a73548baf63deULL, 0x766a0abb3c77b2a8ULL,
+ 0x81c2c92e47edaee6ULL, 0x92722c851482353bULL,
+ 0xa2bfe8a14cf10364ULL, 0xa81a664bbc423001ULL,
+ 0xc24b8b70d0f89791ULL, 0xc76c51a30654be30ULL,
+ 0xd192e819d6ef5218ULL, 0xd69906245565a910ULL,
+ 0xf40e35855771202aULL, 0x106aa07032bbd1b8ULL,
+ 0x19a4c116b8d2d0c8ULL, 0x1e376c085141ab53ULL,
+ 0x2748774cdf8eeb99ULL, 0x34b0bcb5e19b48a8ULL,
+ 0x391c0cb3c5c95a63ULL, 0x4ed8aa4ae3418acbULL,
+ 0x5b9cca4f7763e373ULL, 0x682e6ff3d6b2b8a3ULL,
+ 0x748f82ee5defb2fcULL, 0x78a5636f43172f60ULL,
+ 0x84c87814a1f0ab72ULL, 0x8cc702081a6439ecULL,
+ 0x90befffa23631e28ULL, 0xa4506cebde82bde9ULL,
+ 0xbef9a3f7b2c67915ULL, 0xc67178f2e372532bULL,
+ 0xca273eceea26619cULL, 0xd186b8c721c0c207ULL,
+ 0xeada7dd6cde0eb1eULL, 0xf57d4f7fee6ed178ULL,
+ 0x06f067aa72176fbaULL, 0x0a637dc5a2c898a6ULL,
+ 0x113f9804bef90daeULL, 0x1b710b35131c471bULL,
+ 0x28db77f523047d84ULL, 0x32caab7b40c72493ULL,
+ 0x3c9ebe0a15c9bebcULL, 0x431d67c49c100d4cULL,
+ 0x4cc5d4becb3e42b6ULL, 0x597f299cfc657e2aULL,
+ 0x5fcb6fab3ad6faecULL, 0x6c44198c4a475817ULL
+};
+
+/* Initial hash value H for SHA-384 */
+const static sha2_word64 sha384_initial_hash_value[8] = {
+ 0xcbbb9d5dc1059ed8ULL,
+ 0x629a292a367cd507ULL,
+ 0x9159015a3070dd17ULL,
+ 0x152fecd8f70e5939ULL,
+ 0x67332667ffc00b31ULL,
+ 0x8eb44a8768581511ULL,
+ 0xdb0c2e0d64f98fa7ULL,
+ 0x47b5481dbefa4fa4ULL
+};
+
+/* Initial hash value H for SHA-512 */
+const static sha2_word64 sha512_initial_hash_value[8] = {
+ 0x6a09e667f3bcc908ULL,
+ 0xbb67ae8584caa73bULL,
+ 0x3c6ef372fe94f82bULL,
+ 0xa54ff53a5f1d36f1ULL,
+ 0x510e527fade682d1ULL,
+ 0x9b05688c2b3e6c1fULL,
+ 0x1f83d9abfb41bd6bULL,
+ 0x5be0cd19137e2179ULL
+};
+
+/*
+ * Constant used by SHA256/384/512_End() functions for converting the
+ * digest to a readable hexadecimal character string:
+ */
+static const char *sha2_hex_digits = "0123456789abcdef";
+
+
+/*** SHA-256: *********************************************************/
+void SHA256_Init(SHA256_CTX* context) {
+ if (context == (SHA256_CTX*)0) {
+ return;
+ }
+ MEMCPY_BCOPY(context->state, sha256_initial_hash_value, SHA256_DIGEST_LENGTH);
+ MEMSET_BZERO(context->buffer, SHA256_BLOCK_LENGTH);
+ context->bitcount = 0;
+}
+
+#ifdef SHA2_UNROLL_TRANSFORM
+
+/* Unrolled SHA-256 round macros: */
+
+#if BYTE_ORDER == LITTLE_ENDIAN
+
+#define ROUND256_0_TO_15(a,b,c,d,e,f,g,h) \
+ REVERSE32(*data++, W256[j]); \
+ T1 = (h) + Sigma1_256(e) + Ch((e), (f), (g)) + \
+ K256[j] + W256[j]; \
+ (d) += T1; \
+ (h) = T1 + Sigma0_256(a) + Maj((a), (b), (c)); \
+ j++
+
+
+#else /* BYTE_ORDER == LITTLE_ENDIAN */
+
+#define ROUND256_0_TO_15(a,b,c,d,e,f,g,h) \
+ T1 = (h) + Sigma1_256(e) + Ch((e), (f), (g)) + \
+ K256[j] + (W256[j] = *data++); \
+ (d) += T1; \
+ (h) = T1 + Sigma0_256(a) + Maj((a), (b), (c)); \
+ j++
+
+#endif /* BYTE_ORDER == LITTLE_ENDIAN */
+
+#define ROUND256(a,b,c,d,e,f,g,h) \
+ s0 = W256[(j+1)&0x0f]; \
+ s0 = sigma0_256(s0); \
+ s1 = W256[(j+14)&0x0f]; \
+ s1 = sigma1_256(s1); \
+ T1 = (h) + Sigma1_256(e) + Ch((e), (f), (g)) + K256[j] + \
+ (W256[j&0x0f] += s1 + W256[(j+9)&0x0f] + s0); \
+ (d) += T1; \
+ (h) = T1 + Sigma0_256(a) + Maj((a), (b), (c)); \
+ j++
+
+void SHA256_Transform(SHA256_CTX* context, const sha2_word32* data) {
+ sha2_word32 a, b, c, d, e, f, g, h, s0, s1;
+ sha2_word32 T1, *W256;
+ int j;
+
+ W256 = (sha2_word32*)context->buffer;
+
+ /* Initialize registers with the prev. intermediate value */
+ a = context->state[0];
+ b = context->state[1];
+ c = context->state[2];
+ d = context->state[3];
+ e = context->state[4];
+ f = context->state[5];
+ g = context->state[6];
+ h = context->state[7];
+
+ j = 0;
+ do {
+ /* Rounds 0 to 15 (unrolled): */
+ ROUND256_0_TO_15(a,b,c,d,e,f,g,h);
+ ROUND256_0_TO_15(h,a,b,c,d,e,f,g);
+ ROUND256_0_TO_15(g,h,a,b,c,d,e,f);
+ ROUND256_0_TO_15(f,g,h,a,b,c,d,e);
+ ROUND256_0_TO_15(e,f,g,h,a,b,c,d);
+ ROUND256_0_TO_15(d,e,f,g,h,a,b,c);
+ ROUND256_0_TO_15(c,d,e,f,g,h,a,b);
+ ROUND256_0_TO_15(b,c,d,e,f,g,h,a);
+ } while (j < 16);
+
+ /* Now for the remaining rounds to 64: */
+ do {
+ ROUND256(a,b,c,d,e,f,g,h);
+ ROUND256(h,a,b,c,d,e,f,g);
+ ROUND256(g,h,a,b,c,d,e,f);
+ ROUND256(f,g,h,a,b,c,d,e);
+ ROUND256(e,f,g,h,a,b,c,d);
+ ROUND256(d,e,f,g,h,a,b,c);
+ ROUND256(c,d,e,f,g,h,a,b);
+ ROUND256(b,c,d,e,f,g,h,a);
+ } while (j < 64);
+
+ /* Compute the current intermediate hash value */
+ context->state[0] += a;
+ context->state[1] += b;
+ context->state[2] += c;
+ context->state[3] += d;
+ context->state[4] += e;
+ context->state[5] += f;
+ context->state[6] += g;
+ context->state[7] += h;
+
+ /* Clean up */
+ a = b = c = d = e = f = g = h = T1 = 0;
+}
+
+#else /* SHA2_UNROLL_TRANSFORM */
+
+void SHA256_Transform(SHA256_CTX* context, const sha2_word32* data) {
+ sha2_word32 a, b, c, d, e, f, g, h, s0, s1;
+ sha2_word32 T1, T2, *W256;
+ int j;
+
+ W256 = (sha2_word32*)context->buffer;
+
+ /* Initialize registers with the prev. intermediate value */
+ a = context->state[0];
+ b = context->state[1];
+ c = context->state[2];
+ d = context->state[3];
+ e = context->state[4];
+ f = context->state[5];
+ g = context->state[6];
+ h = context->state[7];
+
+ j = 0;
+ do {
+#if BYTE_ORDER == LITTLE_ENDIAN
+ /* Copy data while converting to host byte order */
+ REVERSE32(*data++,W256[j]);
+ /* Apply the SHA-256 compression function to update a..h */
+ T1 = h + Sigma1_256(e) + Ch(e, f, g) + K256[j] + W256[j];
+#else /* BYTE_ORDER == LITTLE_ENDIAN */
+ /* Apply the SHA-256 compression function to update a..h with copy */
+ T1 = h + Sigma1_256(e) + Ch(e, f, g) + K256[j] + (W256[j] = *data++);
+#endif /* BYTE_ORDER == LITTLE_ENDIAN */
+ T2 = Sigma0_256(a) + Maj(a, b, c);
+ h = g;
+ g = f;
+ f = e;
+ e = d + T1;
+ d = c;
+ c = b;
+ b = a;
+ a = T1 + T2;
+
+ j++;
+ } while (j < 16);
+
+ do {
+ /* Part of the message block expansion: */
+ s0 = W256[(j+1)&0x0f];
+ s0 = sigma0_256(s0);
+ s1 = W256[(j+14)&0x0f];
+ s1 = sigma1_256(s1);
+
+ /* Apply the SHA-256 compression function to update a..h */
+ T1 = h + Sigma1_256(e) + Ch(e, f, g) + K256[j] +
+ (W256[j&0x0f] += s1 + W256[(j+9)&0x0f] + s0);
+ T2 = Sigma0_256(a) + Maj(a, b, c);
+ h = g;
+ g = f;
+ f = e;
+ e = d + T1;
+ d = c;
+ c = b;
+ b = a;
+ a = T1 + T2;
+
+ j++;
+ } while (j < 64);
+
+ /* Compute the current intermediate hash value */
+ context->state[0] += a;
+ context->state[1] += b;
+ context->state[2] += c;
+ context->state[3] += d;
+ context->state[4] += e;
+ context->state[5] += f;
+ context->state[6] += g;
+ context->state[7] += h;
+
+ /* Clean up */
+ a = b = c = d = e = f = g = h = T1 = T2 = 0;
+}
+
+#endif /* SHA2_UNROLL_TRANSFORM */
+
+void SHA256_Update(SHA256_CTX* context, const sha2_byte *data, size_t len) {
+ unsigned int freespace, usedspace;
+
+ if (len == 0) {
+ /* Calling with no data is valid - we do nothing */
+ return;
+ }
+
+ /* Sanity check: */
+ assert(context != (SHA256_CTX*)0 && data != (sha2_byte*)0);
+
+ usedspace = (context->bitcount >> 3) % SHA256_BLOCK_LENGTH;
+ if (usedspace > 0) {
+ /* Calculate how much free space is available in the buffer */
+ freespace = SHA256_BLOCK_LENGTH - usedspace;
+
+ if (len >= freespace) {
+ /* Fill the buffer completely and process it */
+ MEMCPY_BCOPY(&context->buffer[usedspace], data, freespace);
+ context->bitcount += freespace << 3;
+ len -= freespace;
+ data += freespace;
+ SHA256_Transform(context, (sha2_word32*)context->buffer);
+ } else {
+ /* The buffer is not yet full */
+ MEMCPY_BCOPY(&context->buffer[usedspace], data, len);
+ context->bitcount += len << 3;
+ /* Clean up: */
+ usedspace = freespace = 0;
+ return;
+ }
+ }
+ while (len >= SHA256_BLOCK_LENGTH) {
+ /* Process as many complete blocks as we can */
+ SHA256_Transform(context, (sha2_word32*)data);
+ context->bitcount += SHA256_BLOCK_LENGTH << 3;
+ len -= SHA256_BLOCK_LENGTH;
+ data += SHA256_BLOCK_LENGTH;
+ }
+ if (len > 0) {
+ /* There's left-overs, so save 'em */
+ MEMCPY_BCOPY(context->buffer, data, len);
+ context->bitcount += len << 3;
+ }
+ /* Clean up: */
+ usedspace = freespace = 0;
+}
+
+void SHA256_Final(sha2_byte digest[], SHA256_CTX* context) {
+ sha2_word32 *d = (sha2_word32*)digest;
+ unsigned int usedspace;
+
+ /* Sanity check: */
+ assert(context != (SHA256_CTX*)0);
+
+ /* If no digest buffer is passed, we don't bother doing this: */
+ if (digest != (sha2_byte*)0) {
+ usedspace = (context->bitcount >> 3) % SHA256_BLOCK_LENGTH;
+#if BYTE_ORDER == LITTLE_ENDIAN
+ /* Convert FROM host byte order */
+ REVERSE64(context->bitcount,context->bitcount);
+#endif
+ if (usedspace > 0) {
+ /* Begin padding with a 1 bit: */
+ context->buffer[usedspace++] = 0x80;
+
+ if (usedspace <= SHA256_SHORT_BLOCK_LENGTH) {
+ /* Set-up for the last transform: */
+ MEMSET_BZERO(&context->buffer[usedspace], SHA256_SHORT_BLOCK_LENGTH - usedspace);
+ } else {
+ if (usedspace < SHA256_BLOCK_LENGTH) {
+ MEMSET_BZERO(&context->buffer[usedspace], SHA256_BLOCK_LENGTH - usedspace);
+ }
+ /* Do second-to-last transform: */
+ SHA256_Transform(context, (sha2_word32*)context->buffer);
+
+ /* And set-up for the last transform: */
+ MEMSET_BZERO(context->buffer, SHA256_SHORT_BLOCK_LENGTH);
+ }
+ } else {
+ /* Set-up for the last transform: */
+ MEMSET_BZERO(context->buffer, SHA256_SHORT_BLOCK_LENGTH);
+
+ /* Begin padding with a 1 bit: */
+ *context->buffer = 0x80;
+ }
+ /* Set the bit count: */
+ *(sha2_word64*)&context->buffer[SHA256_SHORT_BLOCK_LENGTH] = context->bitcount;
+
+ /* Final transform: */
+ SHA256_Transform(context, (sha2_word32*)context->buffer);
+
+#if BYTE_ORDER == LITTLE_ENDIAN
+ {
+ /* Convert TO host byte order */
+ int j;
+ for (j = 0; j < 8; j++) {
+ REVERSE32(context->state[j],context->state[j]);
+ *d++ = context->state[j];
+ }
+ }
+#else
+ MEMCPY_BCOPY(d, context->state, SHA256_DIGEST_LENGTH);
+#endif
+ }
+
+ /* Clean up state data: */
+ MEMSET_BZERO(context, sizeof(context));
+ usedspace = 0;
+}
+
+char *SHA256_End(SHA256_CTX* context, char buffer[]) {
+ sha2_byte digest[SHA256_DIGEST_LENGTH], *d = digest;
+ int i;
+
+ /* Sanity check: */
+ assert(context != (SHA256_CTX*)0);
+
+ if (buffer != (char*)0) {
+ SHA256_Final(digest, context);
+
+ for (i = 0; i < SHA256_DIGEST_LENGTH; i++) {
+ *buffer++ = sha2_hex_digits[(*d & 0xf0) >> 4];
+ *buffer++ = sha2_hex_digits[*d & 0x0f];
+ d++;
+ }
+ *buffer = (char)0;
+ } else {
+ MEMSET_BZERO(context, sizeof(context));
+ }
+ MEMSET_BZERO(digest, SHA256_DIGEST_LENGTH);
+ return buffer;
+}
+
+char* SHA256_Data(const sha2_byte* data, size_t len, char digest[SHA256_DIGEST_STRING_LENGTH]) {
+ SHA256_CTX context;
+
+ SHA256_Init(&context);
+ SHA256_Update(&context, data, len);
+ return SHA256_End(&context, digest);
+}
+
+
+/*** SHA-512: *********************************************************/
+void SHA512_Init(SHA512_CTX* context) {
+ if (context == (SHA512_CTX*)0) {
+ return;
+ }
+ MEMCPY_BCOPY(context->state, sha512_initial_hash_value, SHA512_DIGEST_LENGTH);
+ MEMSET_BZERO(context->buffer, SHA512_BLOCK_LENGTH);
+ context->bitcount[0] = context->bitcount[1] = 0;
+}
+
+#ifdef SHA2_UNROLL_TRANSFORM
+
+/* Unrolled SHA-512 round macros: */
+#if BYTE_ORDER == LITTLE_ENDIAN
+
+#define ROUND512_0_TO_15(a,b,c,d,e,f,g,h) \
+ REVERSE64(*data++, W512[j]); \
+ T1 = (h) + Sigma1_512(e) + Ch((e), (f), (g)) + \
+ K512[j] + W512[j]; \
+ (d) += T1, \
+ (h) = T1 + Sigma0_512(a) + Maj((a), (b), (c)), \
+ j++
+
+
+#else /* BYTE_ORDER == LITTLE_ENDIAN */
+
+#define ROUND512_0_TO_15(a,b,c,d,e,f,g,h) \
+ T1 = (h) + Sigma1_512(e) + Ch((e), (f), (g)) + \
+ K512[j] + (W512[j] = *data++); \
+ (d) += T1; \
+ (h) = T1 + Sigma0_512(a) + Maj((a), (b), (c)); \
+ j++
+
+#endif /* BYTE_ORDER == LITTLE_ENDIAN */
+
+#define ROUND512(a,b,c,d,e,f,g,h) \
+ s0 = W512[(j+1)&0x0f]; \
+ s0 = sigma0_512(s0); \
+ s1 = W512[(j+14)&0x0f]; \
+ s1 = sigma1_512(s1); \
+ T1 = (h) + Sigma1_512(e) + Ch((e), (f), (g)) + K512[j] + \
+ (W512[j&0x0f] += s1 + W512[(j+9)&0x0f] + s0); \
+ (d) += T1; \
+ (h) = T1 + Sigma0_512(a) + Maj((a), (b), (c)); \
+ j++
+
+void SHA512_Transform(SHA512_CTX* context, const sha2_word64* data) {
+ sha2_word64 a, b, c, d, e, f, g, h, s0, s1;
+ sha2_word64 T1, *W512 = (sha2_word64*)context->buffer;
+ int j;
+
+ /* Initialize registers with the prev. intermediate value */
+ a = context->state[0];
+ b = context->state[1];
+ c = context->state[2];
+ d = context->state[3];
+ e = context->state[4];
+ f = context->state[5];
+ g = context->state[6];
+ h = context->state[7];
+
+ j = 0;
+ do {
+ ROUND512_0_TO_15(a,b,c,d,e,f,g,h);
+ ROUND512_0_TO_15(h,a,b,c,d,e,f,g);
+ ROUND512_0_TO_15(g,h,a,b,c,d,e,f);
+ ROUND512_0_TO_15(f,g,h,a,b,c,d,e);
+ ROUND512_0_TO_15(e,f,g,h,a,b,c,d);
+ ROUND512_0_TO_15(d,e,f,g,h,a,b,c);
+ ROUND512_0_TO_15(c,d,e,f,g,h,a,b);
+ ROUND512_0_TO_15(b,c,d,e,f,g,h,a);
+ } while (j < 16);
+
+ /* Now for the remaining rounds up to 79: */
+ do {
+ ROUND512(a,b,c,d,e,f,g,h);
+ ROUND512(h,a,b,c,d,e,f,g);
+ ROUND512(g,h,a,b,c,d,e,f);
+ ROUND512(f,g,h,a,b,c,d,e);
+ ROUND512(e,f,g,h,a,b,c,d);
+ ROUND512(d,e,f,g,h,a,b,c);
+ ROUND512(c,d,e,f,g,h,a,b);
+ ROUND512(b,c,d,e,f,g,h,a);
+ } while (j < 80);
+
+ /* Compute the current intermediate hash value */
+ context->state[0] += a;
+ context->state[1] += b;
+ context->state[2] += c;
+ context->state[3] += d;
+ context->state[4] += e;
+ context->state[5] += f;
+ context->state[6] += g;
+ context->state[7] += h;
+
+ /* Clean up */
+ a = b = c = d = e = f = g = h = T1 = 0;
+}
+
+#else /* SHA2_UNROLL_TRANSFORM */
+
+void SHA512_Transform(SHA512_CTX* context, const sha2_word64* data) {
+ sha2_word64 a, b, c, d, e, f, g, h, s0, s1;
+ sha2_word64 T1, T2, *W512 = (sha2_word64*)context->buffer;
+ int j;
+
+ /* Initialize registers with the prev. intermediate value */
+ a = context->state[0];
+ b = context->state[1];
+ c = context->state[2];
+ d = context->state[3];
+ e = context->state[4];
+ f = context->state[5];
+ g = context->state[6];
+ h = context->state[7];
+
+ j = 0;
+ do {
+#if BYTE_ORDER == LITTLE_ENDIAN
+ /* Convert TO host byte order */
+ REVERSE64(*data++, W512[j]);
+ /* Apply the SHA-512 compression function to update a..h */
+ T1 = h + Sigma1_512(e) + Ch(e, f, g) + K512[j] + W512[j];
+#else /* BYTE_ORDER == LITTLE_ENDIAN */
+ /* Apply the SHA-512 compression function to update a..h with copy */
+ T1 = h + Sigma1_512(e) + Ch(e, f, g) + K512[j] + (W512[j] = *data++);
+#endif /* BYTE_ORDER == LITTLE_ENDIAN */
+ T2 = Sigma0_512(a) + Maj(a, b, c);
+ h = g;
+ g = f;
+ f = e;
+ e = d + T1;
+ d = c;
+ c = b;
+ b = a;
+ a = T1 + T2;
+
+ j++;
+ } while (j < 16);
+
+ do {
+ /* Part of the message block expansion: */
+ s0 = W512[(j+1)&0x0f];
+ s0 = sigma0_512(s0);
+ s1 = W512[(j+14)&0x0f];
+ s1 = sigma1_512(s1);
+
+ /* Apply the SHA-512 compression function to update a..h */
+ T1 = h + Sigma1_512(e) + Ch(e, f, g) + K512[j] +
+ (W512[j&0x0f] += s1 + W512[(j+9)&0x0f] + s0);
+ T2 = Sigma0_512(a) + Maj(a, b, c);
+ h = g;
+ g = f;
+ f = e;
+ e = d + T1;
+ d = c;
+ c = b;
+ b = a;
+ a = T1 + T2;
+
+ j++;
+ } while (j < 80);
+
+ /* Compute the current intermediate hash value */
+ context->state[0] += a;
+ context->state[1] += b;
+ context->state[2] += c;
+ context->state[3] += d;
+ context->state[4] += e;
+ context->state[5] += f;
+ context->state[6] += g;
+ context->state[7] += h;
+
+ /* Clean up */
+ a = b = c = d = e = f = g = h = T1 = T2 = 0;
+}
+
+#endif /* SHA2_UNROLL_TRANSFORM */
+
+void SHA512_Update(SHA512_CTX* context, const sha2_byte *data, size_t len) {
+ unsigned int freespace, usedspace;
+
+ if (len == 0) {
+ /* Calling with no data is valid - we do nothing */
+ return;
+ }
+
+ /* Sanity check: */
+ assert(context != (SHA512_CTX*)0 && data != (sha2_byte*)0);
+
+ usedspace = (context->bitcount[0] >> 3) % SHA512_BLOCK_LENGTH;
+ if (usedspace > 0) {
+ /* Calculate how much free space is available in the buffer */
+ freespace = SHA512_BLOCK_LENGTH - usedspace;
+
+ if (len >= freespace) {
+ /* Fill the buffer completely and process it */
+ MEMCPY_BCOPY(&context->buffer[usedspace], data, freespace);
+ ADDINC128(context->bitcount, freespace << 3);
+ len -= freespace;
+ data += freespace;
+ SHA512_Transform(context, (sha2_word64*)context->buffer);
+ } else {
+ /* The buffer is not yet full */
+ MEMCPY_BCOPY(&context->buffer[usedspace], data, len);
+ ADDINC128(context->bitcount, len << 3);
+ /* Clean up: */
+ usedspace = freespace = 0;
+ return;
+ }
+ }
+ while (len >= SHA512_BLOCK_LENGTH) {
+ /* Process as many complete blocks as we can */
+ SHA512_Transform(context, (sha2_word64*)data);
+ ADDINC128(context->bitcount, SHA512_BLOCK_LENGTH << 3);
+ len -= SHA512_BLOCK_LENGTH;
+ data += SHA512_BLOCK_LENGTH;
+ }
+ if (len > 0) {
+ /* There's left-overs, so save 'em */
+ MEMCPY_BCOPY(context->buffer, data, len);
+ ADDINC128(context->bitcount, len << 3);
+ }
+ /* Clean up: */
+ usedspace = freespace = 0;
+}
+
+void SHA512_Last(SHA512_CTX* context) {
+ unsigned int usedspace;
+
+ usedspace = (context->bitcount[0] >> 3) % SHA512_BLOCK_LENGTH;
+#if BYTE_ORDER == LITTLE_ENDIAN
+ /* Convert FROM host byte order */
+ REVERSE64(context->bitcount[0],context->bitcount[0]);
+ REVERSE64(context->bitcount[1],context->bitcount[1]);
+#endif
+ if (usedspace > 0) {
+ /* Begin padding with a 1 bit: */
+ context->buffer[usedspace++] = 0x80;
+
+ if (usedspace <= SHA512_SHORT_BLOCK_LENGTH) {
+ /* Set-up for the last transform: */
+ MEMSET_BZERO(&context->buffer[usedspace], SHA512_SHORT_BLOCK_LENGTH - usedspace);
+ } else {
+ if (usedspace < SHA512_BLOCK_LENGTH) {
+ MEMSET_BZERO(&context->buffer[usedspace], SHA512_BLOCK_LENGTH - usedspace);
+ }
+ /* Do second-to-last transform: */
+ SHA512_Transform(context, (sha2_word64*)context->buffer);
+
+ /* And set-up for the last transform: */
+ MEMSET_BZERO(context->buffer, SHA512_BLOCK_LENGTH - 2);
+ }
+ } else {
+ /* Prepare for final transform: */
+ MEMSET_BZERO(context->buffer, SHA512_SHORT_BLOCK_LENGTH);
+
+ /* Begin padding with a 1 bit: */
+ *context->buffer = 0x80;
+ }
+ /* Store the length of input data (in bits): */
+ *(sha2_word64*)&context->buffer[SHA512_SHORT_BLOCK_LENGTH] = context->bitcount[1];
+ *(sha2_word64*)&context->buffer[SHA512_SHORT_BLOCK_LENGTH+8] = context->bitcount[0];
+
+ /* Final transform: */
+ SHA512_Transform(context, (sha2_word64*)context->buffer);
+}
+
+void SHA512_Final(sha2_byte digest[], SHA512_CTX* context) {
+ sha2_word64 *d = (sha2_word64*)digest;
+
+ /* Sanity check: */
+ assert(context != (SHA512_CTX*)0);
+
+ /* If no digest buffer is passed, we don't bother doing this: */
+ if (digest != (sha2_byte*)0) {
+ SHA512_Last(context);
+
+ /* Save the hash data for output: */
+#if BYTE_ORDER == LITTLE_ENDIAN
+ {
+ /* Convert TO host byte order */
+ int j;
+ for (j = 0; j < 8; j++) {
+ REVERSE64(context->state[j],context->state[j]);
+ *d++ = context->state[j];
+ }
+ }
+#else
+ MEMCPY_BCOPY(d, context->state, SHA512_DIGEST_LENGTH);
+#endif
+ }
+
+ /* Zero out state data */
+ MEMSET_BZERO(context, sizeof(context));
+}
+
+char *SHA512_End(SHA512_CTX* context, char buffer[]) {
+ sha2_byte digest[SHA512_DIGEST_LENGTH], *d = digest;
+ int i;
+
+ /* Sanity check: */
+ assert(context != (SHA512_CTX*)0);
+
+ if (buffer != (char*)0) {
+ SHA512_Final(digest, context);
+
+ for (i = 0; i < SHA512_DIGEST_LENGTH; i++) {
+ *buffer++ = sha2_hex_digits[(*d & 0xf0) >> 4];
+ *buffer++ = sha2_hex_digits[*d & 0x0f];
+ d++;
+ }
+ *buffer = (char)0;
+ } else {
+ MEMSET_BZERO(context, sizeof(context));
+ }
+ MEMSET_BZERO(digest, SHA512_DIGEST_LENGTH);
+ return buffer;
+}
+
+char* SHA512_Data(const sha2_byte* data, size_t len, char digest[SHA512_DIGEST_STRING_LENGTH]) {
+ SHA512_CTX context;
+
+ SHA512_Init(&context);
+ SHA512_Update(&context, data, len);
+ return SHA512_End(&context, digest);
+}
+
+
+/*** SHA-384: *********************************************************/
+void SHA384_Init(SHA384_CTX* context) {
+ if (context == (SHA384_CTX*)0) {
+ return;
+ }
+ MEMCPY_BCOPY(context->state, sha384_initial_hash_value, SHA512_DIGEST_LENGTH);
+ MEMSET_BZERO(context->buffer, SHA384_BLOCK_LENGTH);
+ context->bitcount[0] = context->bitcount[1] = 0;
+}
+
+void SHA384_Update(SHA384_CTX* context, const sha2_byte* data, size_t len) {
+ SHA512_Update((SHA512_CTX*)context, data, len);
+}
+
+void SHA384_Final(sha2_byte digest[], SHA384_CTX* context) {
+ sha2_word64 *d = (sha2_word64*)digest;
+
+ /* Sanity check: */
+ assert(context != (SHA384_CTX*)0);
+
+ /* If no digest buffer is passed, we don't bother doing this: */
+ if (digest != (sha2_byte*)0) {
+ SHA512_Last((SHA512_CTX*)context);
+
+ /* Save the hash data for output: */
+#if BYTE_ORDER == LITTLE_ENDIAN
+ {
+ /* Convert TO host byte order */
+ int j;
+ for (j = 0; j < 6; j++) {
+ REVERSE64(context->state[j],context->state[j]);
+ *d++ = context->state[j];
+ }
+ }
+#else
+ MEMCPY_BCOPY(d, context->state, SHA384_DIGEST_LENGTH);
+#endif
+ }
+
+ /* Zero out state data */
+ MEMSET_BZERO(context, sizeof(context));
+}
+
+char *SHA384_End(SHA384_CTX* context, char buffer[]) {
+ sha2_byte digest[SHA384_DIGEST_LENGTH], *d = digest;
+ int i;
+
+ /* Sanity check: */
+ assert(context != (SHA384_CTX*)0);
+
+ if (buffer != (char*)0) {
+ SHA384_Final(digest, context);
+
+ for (i = 0; i < SHA384_DIGEST_LENGTH; i++) {
+ *buffer++ = sha2_hex_digits[(*d & 0xf0) >> 4];
+ *buffer++ = sha2_hex_digits[*d & 0x0f];
+ d++;
+ }
+ *buffer = (char)0;
+ } else {
+ MEMSET_BZERO(context, sizeof(context));
+ }
+ MEMSET_BZERO(digest, SHA384_DIGEST_LENGTH);
+ return buffer;
+}
+
+char* SHA384_Data(const sha2_byte* data, size_t len, char digest[SHA384_DIGEST_STRING_LENGTH]) {
+ SHA384_CTX context;
+
+ SHA384_Init(&context);
+ SHA384_Update(&context, data, len);
+ return SHA384_End(&context, digest);
+}
+
diff --git a/src/sha2.h b/src/sha2.h
new file mode 100644
index 0000000..bf759ad
--- /dev/null
+++ b/src/sha2.h
@@ -0,0 +1,197 @@
+/*
+ * FILE: sha2.h
+ * AUTHOR: Aaron D. Gifford - http://www.aarongifford.com/
+ *
+ * Copyright (c) 2000-2001, Aaron D. Gifford
+ * All rights reserved.
+ *
+ * Redistribution and use in source and binary forms, with or without
+ * modification, are permitted provided that the following conditions
+ * are met:
+ * 1. Redistributions of source code must retain the above copyright
+ * notice, this list of conditions and the following disclaimer.
+ * 2. Redistributions in binary form must reproduce the above copyright
+ * notice, this list of conditions and the following disclaimer in the
+ * documentation and/or other materials provided with the distribution.
+ * 3. Neither the name of the copyright holder nor the names of contributors
+ * may be used to endorse or promote products derived from this software
+ * without specific prior written permission.
+ *
+ * THIS SOFTWARE IS PROVIDED BY THE AUTHOR AND CONTRIBUTOR(S) ``AS IS'' AND
+ * ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
+ * IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE
+ * ARE DISCLAIMED. IN NO EVENT SHALL THE AUTHOR OR CONTRIBUTOR(S) BE LIABLE
+ * FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL
+ * DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS
+ * OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION)
+ * HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT
+ * LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY
+ * OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF
+ * SUCH DAMAGE.
+ *
+ * $Id: sha2.h,v 1.1 2001/11/08 00:02:01 adg Exp adg $
+ */
+
+#ifndef __SHA2_H__
+#define __SHA2_H__
+
+#ifdef __cplusplus
+extern "C" {
+#endif
+
+
+/*
+ * Import u_intXX_t size_t type definitions from system headers. You
+ * may need to change this, or define these things yourself in this
+ * file.
+ */
+#include
+
+#ifdef SHA2_USE_INTTYPES_H
+
+#include
+
+#endif /* SHA2_USE_INTTYPES_H */
+
+
+/*** SHA-256/384/512 Various Length Definitions ***********************/
+#define SHA256_BLOCK_LENGTH 64
+#define SHA256_DIGEST_LENGTH 32
+#define SHA256_DIGEST_STRING_LENGTH (SHA256_DIGEST_LENGTH * 2 + 1)
+#define SHA384_BLOCK_LENGTH 128
+#define SHA384_DIGEST_LENGTH 48
+#define SHA384_DIGEST_STRING_LENGTH (SHA384_DIGEST_LENGTH * 2 + 1)
+#define SHA512_BLOCK_LENGTH 128
+#define SHA512_DIGEST_LENGTH 64
+#define SHA512_DIGEST_STRING_LENGTH (SHA512_DIGEST_LENGTH * 2 + 1)
+
+
+/*** SHA-256/384/512 Context Structures *******************************/
+/* NOTE: If your architecture does not define either u_intXX_t types or
+ * uintXX_t (from inttypes.h), you may need to define things by hand
+ * for your system:
+ */
+#if 0
+typedef unsigned char u_int8_t; /* 1-byte (8-bits) */
+typedef unsigned int u_int32_t; /* 4-bytes (32-bits) */
+typedef unsigned long long u_int64_t; /* 8-bytes (64-bits) */
+#endif
+/*
+ * Most BSD systems already define u_intXX_t types, as does Linux.
+ * Some systems, however, like Compaq's Tru64 Unix instead can use
+ * uintXX_t types defined by very recent ANSI C standards and included
+ * in the file:
+ *
+ * #include
+ *
+ * If you choose to use then please define:
+ *
+ * #define SHA2_USE_INTTYPES_H
+ *
+ * Or on the command line during compile:
+ *
+ * cc -DSHA2_USE_INTTYPES_H ...
+ */
+#ifdef SHA2_USE_INTTYPES_H
+
+typedef struct _SHA256_CTX {
+ uint32_t state[8];
+ uint64_t bitcount;
+ uint8_t buffer[SHA256_BLOCK_LENGTH];
+} SHA256_CTX;
+typedef struct _SHA512_CTX {
+ uint64_t state[8];
+ uint64_t bitcount[2];
+ uint8_t buffer[SHA512_BLOCK_LENGTH];
+} SHA512_CTX;
+
+#else /* SHA2_USE_INTTYPES_H */
+
+typedef struct _SHA256_CTX {
+ u_int32_t state[8];
+ u_int64_t bitcount;
+ u_int8_t buffer[SHA256_BLOCK_LENGTH];
+} SHA256_CTX;
+typedef struct _SHA512_CTX {
+ u_int64_t state[8];
+ u_int64_t bitcount[2];
+ u_int8_t buffer[SHA512_BLOCK_LENGTH];
+} SHA512_CTX;
+
+#endif /* SHA2_USE_INTTYPES_H */
+
+typedef SHA512_CTX SHA384_CTX;
+
+
+/*** SHA-256/384/512 Function Prototypes ******************************/
+#ifndef NOPROTO
+#ifdef SHA2_USE_INTTYPES_H
+
+void SHA256_Init(SHA256_CTX *);
+void SHA256_Update(SHA256_CTX*, const uint8_t*, size_t);
+void SHA256_Final(uint8_t[SHA256_DIGEST_LENGTH], SHA256_CTX*);
+char* SHA256_End(SHA256_CTX*, char[SHA256_DIGEST_STRING_LENGTH]);
+char* SHA256_Data(const uint8_t*, size_t, char[SHA256_DIGEST_STRING_LENGTH]);
+
+void SHA384_Init(SHA384_CTX*);
+void SHA384_Update(SHA384_CTX*, const uint8_t*, size_t);
+void SHA384_Final(uint8_t[SHA384_DIGEST_LENGTH], SHA384_CTX*);
+char* SHA384_End(SHA384_CTX*, char[SHA384_DIGEST_STRING_LENGTH]);
+char* SHA384_Data(const uint8_t*, size_t, char[SHA384_DIGEST_STRING_LENGTH]);
+
+void SHA512_Init(SHA512_CTX*);
+void SHA512_Update(SHA512_CTX*, const uint8_t*, size_t);
+void SHA512_Final(uint8_t[SHA512_DIGEST_LENGTH], SHA512_CTX*);
+char* SHA512_End(SHA512_CTX*, char[SHA512_DIGEST_STRING_LENGTH]);
+char* SHA512_Data(const uint8_t*, size_t, char[SHA512_DIGEST_STRING_LENGTH]);
+
+#else /* SHA2_USE_INTTYPES_H */
+
+void SHA256_Init(SHA256_CTX *);
+void SHA256_Update(SHA256_CTX*, const u_int8_t*, size_t);
+void SHA256_Final(u_int8_t[SHA256_DIGEST_LENGTH], SHA256_CTX*);
+char* SHA256_End(SHA256_CTX*, char[SHA256_DIGEST_STRING_LENGTH]);
+char* SHA256_Data(const u_int8_t*, size_t, char[SHA256_DIGEST_STRING_LENGTH]);
+
+void SHA384_Init(SHA384_CTX*);
+void SHA384_Update(SHA384_CTX*, const u_int8_t*, size_t);
+void SHA384_Final(u_int8_t[SHA384_DIGEST_LENGTH], SHA384_CTX*);
+char* SHA384_End(SHA384_CTX*, char[SHA384_DIGEST_STRING_LENGTH]);
+char* SHA384_Data(const u_int8_t*, size_t, char[SHA384_DIGEST_STRING_LENGTH]);
+
+void SHA512_Init(SHA512_CTX*);
+void SHA512_Update(SHA512_CTX*, const u_int8_t*, size_t);
+void SHA512_Final(u_int8_t[SHA512_DIGEST_LENGTH], SHA512_CTX*);
+char* SHA512_End(SHA512_CTX*, char[SHA512_DIGEST_STRING_LENGTH]);
+char* SHA512_Data(const u_int8_t*, size_t, char[SHA512_DIGEST_STRING_LENGTH]);
+
+#endif /* SHA2_USE_INTTYPES_H */
+
+#else /* NOPROTO */
+
+void SHA256_Init();
+void SHA256_Update();
+void SHA256_Final();
+char* SHA256_End();
+char* SHA256_Data();
+
+void SHA384_Init();
+void SHA384_Update();
+void SHA384_Final();
+char* SHA384_End();
+char* SHA384_Data();
+
+void SHA512_Init();
+void SHA512_Update();
+void SHA512_Final();
+char* SHA512_End();
+char* SHA512_Data();
+
+#endif /* NOPROTO */
+
+#ifdef __cplusplus
+}
+#endif /* __cplusplus */
+
+#endif /* __SHA2_H__ */
+
diff --git a/src/signatures.h b/src/signatures.h
new file mode 100644
index 0000000..6027f80
--- /dev/null
+++ b/src/signatures.h
@@ -0,0 +1,23 @@
+
+/*
+ * This file is part of Codecrypt.
+ *
+ * Codecrypt is free software: you can redistribute it and/or modify it
+ * under the terms of the GNU Lesser General Public License as published by
+ * the Free Software Foundation, either version 3 of the License, or (at
+ * your option) any later version.
+ *
+ * Codecrypt is distributed in the hope that it will be useful, but WITHOUT
+ * ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+ * FITNESS FOR A PARTICULAR PURPOSE. See the GNU Lesser General Public
+ * License for more details.
+ *
+ * You should have received a copy of the GNU Lesser General Public License
+ * along with Codecrypt. If not, see .
+ */
+
+#ifndef _ccr_sigs_h_
+#define _ccr_sigs_h_
+
+#endif
+