本文整理汇总了C++中mat_ZZ_p类的典型用法代码示例。如果您正苦于以下问题:C++ mat_ZZ_p类的具体用法?C++ mat_ZZ_p怎么用?C++ mat_ZZ_p使用的例子?那么恭喜您, 这里精选的类代码示例或许可以为您提供帮助。
在下文中一共展示了mat_ZZ_p类的20个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于我们的系统推荐出更棒的C++代码示例。
示例1: power
void power(mat_ZZ_p& X, const mat_ZZ_p& A, const ZZ& e)
{
if (A.NumRows() != A.NumCols()) Error("power: non-square matrix");
if (e == 0) {
ident(X, A.NumRows());
return;
}
mat_ZZ_p T1, T2;
long i, k;
k = NumBits(e);
T1 = A;
for (i = k-2; i >= 0; i--) {
sqr(T2, T1);
if (bit(e, i))
mul(T1, T2, A);
else
T1 = T2;
}
if (e < 0)
inv(X, T1);
else
X = T1;
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:28,代码来源:mat_ZZ_p.c
示例2: to_mat_ZZ_p_crt_rep
void to_mat_ZZ_p_crt_rep(mat_ZZ_p_crt_rep& X, const mat_ZZ_p& A)
{
long n = A.NumRows();
long m = A.NumCols();
const MatPrime_crt_helper& H = get_MatPrime_crt_helper_info();
long nprimes = H.GetNumPrimes();
if (NTL_OVERFLOW(nprimes, CRT_BLK, 0))
ResourceError("overflow"); // this is pretty academic
X.rep.SetLength(nprimes);
for (long k = 0; k < nprimes; k++) X.rep[k].SetDims(n, m);
ZZ_pContext context;
context.save();
bool seq = (double(n)*double(m)*H.GetCost() < PAR_THRESH);
// FIXME: right now, we just partition the rows, but if
// #cols > #rows, we should perhaps partition the cols
NTL_GEXEC_RANGE(seq, n, first, last)
NTL_IMPORT(n)
NTL_IMPORT(m)
NTL_IMPORT(nprimes)
context.restore();
MatPrime_crt_helper_scratch scratch;
Vec<MatPrime_residue_t> remainders_store;
remainders_store.SetLength(nprimes*CRT_BLK);
MatPrime_residue_t *remainders = remainders_store.elts();
for (long i = first; i < last; i++) {
const ZZ_p *a = A[i].elts();
long jj = 0;
for (; jj <= m-CRT_BLK; jj += CRT_BLK) {
for (long j = 0; j < CRT_BLK; j++)
reduce(H, rep(a[jj+j]), remainders + j*nprimes, scratch);
for (long k = 0; k < nprimes; k++) {
MatPrime_residue_t *x = X.rep[k][i].elts();
for (long j = 0; j < CRT_BLK; j++)
x[jj+j] = remainders[j*nprimes+k];
}
}
if (jj < m) {
for (long j = 0; j < m-jj; j++)
reduce(H, rep(a[jj+j]), remainders + j*nprimes, scratch);
for (long k = 0; k < nprimes; k++) {
MatPrime_residue_t *x = X.rep[k][i].elts();
for (long j = 0; j < m-jj; j++)
x[jj+j] = remainders[j*nprimes+k];
}
}
}
NTL_GEXEC_RANGE_END
}
开发者ID:tell,项目名称:ntl-unix,代码行数:60,代码来源:mat_ZZ_p.cpp
示例3: mul_aux
void mul_aux(mat_ZZ_p& X, const mat_ZZ_p& A, const mat_ZZ_p& B)
{
long n = A.NumRows();
long l = A.NumCols();
long m = B.NumCols();
if (l != B.NumRows())
Error("matrix mul: dimension mismatch");
X.SetDims(n, m);
long i, j, k;
ZZ acc, tmp;
for (i = 1; i <= n; i++) {
for (j = 1; j <= m; j++) {
clear(acc);
for(k = 1; k <= l; k++) {
mul(tmp, rep(A(i,k)), rep(B(k,j)));
add(acc, acc, tmp);
}
conv(X(i,j), acc);
}
}
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:25,代码来源:mat_ZZ_p.c
示例4: transpose
void transpose(mat_ZZ_p& X, const mat_ZZ_p& A)
{
long n = A.NumRows();
long m = A.NumCols();
long i, j;
if (&X == & A) {
if (n == m)
for (i = 1; i <= n; i++)
for (j = i+1; j <= n; j++)
swap(X(i, j), X(j, i));
else {
mat_ZZ_p tmp;
tmp.SetDims(m, n);
for (i = 1; i <= n; i++)
for (j = 1; j <= m; j++)
tmp(j, i) = A(i, j);
X.kill();
X = tmp;
}
}
else {
X.SetDims(m, n);
for (i = 1; i <= n; i++)
for (j = 1; j <= m; j++)
X(j, i) = A(i, j);
}
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:29,代码来源:mat_ZZ_p.c
示例5: negate
void negate(mat_ZZ_p& X, const mat_ZZ_p& A)
{
long n = A.NumRows();
long m = A.NumCols();
X.SetDims(n, m);
long i, j;
for (i = 1; i <= n; i++)
for (j = 1; j <= m; j++)
negate(X(i,j), A(i,j));
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:13,代码来源:mat_ZZ_p.c
示例6: mul
void mul(mat_ZZ_p& X, const mat_ZZ_p& A, const mat_ZZ_p& B)
{
long n = A.NumRows();
long l = A.NumCols();
long m = B.NumCols();
if (l != B.NumRows()) LogicError("matrix mul: dimension mismatch");
if (NTL_USE_MM_MATMUL && n >= 24 && l >= 24 && m >= 24)
multi_modular_mul(X, A, B);
else
plain_mul(X, A, B);
}
开发者ID:tell,项目名称:ntl-unix,代码行数:13,代码来源:mat_ZZ_p.cpp
示例7: mul
void mul(mat_ZZ_p& X, const mat_ZZ_p& A, long b_in)
{
NTL_ZZ_pRegister(b);
b = b_in;
long n = A.NumRows();
long m = A.NumCols();
X.SetDims(n, m);
long i, j;
for (i = 0; i < n; i++)
for (j = 0; j < m; j++)
mul(X[i][j], A[i][j], b);
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:14,代码来源:mat_ZZ_p.c
示例8: sub
void sub(mat_ZZ_p& X, const mat_ZZ_p& A, const mat_ZZ_p& B)
{
long n = A.NumRows();
long m = A.NumCols();
if (B.NumRows() != n || B.NumCols() != m)
Error("matrix sub: dimension mismatch");
X.SetDims(n, m);
long i, j;
for (i = 1; i <= n; i++)
for (j = 1; j <= m; j++)
sub(X(i,j), A(i,j), B(i,j));
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:15,代码来源:mat_ZZ_p.c
示例9: clear
void clear(mat_ZZ_p& x)
{
long n = x.NumRows();
long i;
for (i = 0; i < n; i++)
clear(x[i]);
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:7,代码来源:mat_ZZ_p.c
示例10: multi_modular_mul
void multi_modular_mul(mat_ZZ_p& X, const mat_ZZ_p& A, const mat_ZZ_p& B)
{
long l = A.NumCols();
if (l != B.NumRows())
LogicError("matrix mul: dimension mismatch");
if (l > NTL_MatPrimeLimit)
ResourceError("matrix mul: dimension too large");
mat_ZZ_p_crt_rep x, a, b;
to_mat_ZZ_p_crt_rep(a, A);
to_mat_ZZ_p_crt_rep(b, B);
mul(x, a, b);
from_mat_ZZ_p_crt_rep(x, X);
}
开发者ID:tell,项目名称:ntl-unix,代码行数:17,代码来源:mat_ZZ_p.cpp
示例11: add
NTL_START_IMPL
void add(mat_ZZ_p& X, const mat_ZZ_p& A, const mat_ZZ_p& B)
{
long n = A.NumRows();
long m = A.NumCols();
if (B.NumRows() != n || B.NumCols() != m)
LogicError("matrix add: dimension mismatch");
X.SetDims(n, m);
long i, j;
for (i = 1; i <= n; i++)
for (j = 1; j <= m; j++)
add(X(i,j), A(i,j), B(i,j));
}
开发者ID:axelexic,项目名称:NTL,代码行数:18,代码来源:mat_ZZ_p.c
示例12: IsDiag
long IsDiag(const mat_ZZ_p& A, long n, const ZZ_p& d)
{
if (A.NumRows() != n || A.NumCols() != n)
return 0;
long i, j;
for (i = 1; i <= n; i++)
for (j = 1; j <= n; j++)
if (i != j) {
if (!IsZero(A(i, j))) return 0;
}
else {
if (A(i, j) != d) return 0;
}
return 1;
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:18,代码来源:mat_ZZ_p.c
示例13: IsIdent
long IsIdent(const mat_ZZ_p& A, long n)
{
if (A.NumRows() != n || A.NumCols() != n)
return 0;
long i, j;
for (i = 1; i <= n; i++)
for (j = 1; j <= n; j++)
if (i != j) {
if (!IsZero(A(i, j))) return 0;
}
else {
if (!IsOne(A(i, j))) return 0;
}
return 1;
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:18,代码来源:mat_ZZ_p.c
示例14: conv
void conv(mat_ZZ_p& x, const mat_ZZ& a)
{
long n = a.NumRows();
long m = a.NumCols();
long i;
x.SetDims(n, m);
for (i = 0; i < n; i++)
conv(x[i], a[i]);
}
开发者ID:tvtritin,项目名称:Fuzzy-extractor,代码行数:10,代码来源:mat_ZZ.c
示例15: plain_mul_transpose_aux
void plain_mul_transpose_aux(mat_ZZ_p& X, const mat_ZZ_p& A, const mat_ZZ_p& B)
{
long n = A.NumRows();
long l = A.NumCols();
long m = B.NumRows();
if (l != B.NumCols())
LogicError("matrix mul: dimension mismatch");
X.SetDims(n, m);
ZZ_pContext context;
context.save();
long sz = ZZ_p::ModulusSize();
bool seq = (double(n)*double(l)*double(m)*double(sz)*double(sz) < PAR_THRESH);
NTL_GEXEC_RANGE(seq, m, first, last)
NTL_IMPORT(n)
NTL_IMPORT(l)
NTL_IMPORT(m)
context.restore();
long i, j, k;
ZZ acc, tmp;
for (j = first; j < last; j++) {
const ZZ_p *B_col = B[j].elts();
for (i = 0; i < n; i++) {
clear(acc);
for (k = 0; k < l; k++) {
mul(tmp, rep(A[i][k]), rep(B_col[k]));
add(acc, acc, tmp);
}
conv(X[i][j], acc);
}
}
NTL_GEXEC_RANGE_END
}
开发者ID:tell,项目名称:ntl-unix,代码行数:42,代码来源:mat_ZZ_p.cpp
示例16: IsZero
long IsZero(const mat_ZZ_p& a)
{
long n = a.NumRows();
long i;
for (i = 0; i < n; i++)
if (!IsZero(a[i]))
return 0;
return 1;
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:11,代码来源:mat_ZZ_p.c
示例17: ident
void ident(mat_ZZ_p& X, long n)
{
X.SetDims(n, n);
long i, j;
for (i = 1; i <= n; i++)
for (j = 1; j <= n; j++)
if (i == j)
set(X(i, j));
else
clear(X(i, j));
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:12,代码来源:mat_ZZ_p.c
示例18: initMatrix
void Testbench::initMatrix(mat_ZZ_p & m, int int_size) {
ZZ_p n;
n.init(to_ZZ("56563749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995"));
switch (int_size) {
case 64:
n = to_ZZ_p(to_ZZ("9999999999999999995"));
break;
case 128:
n = to_ZZ_p(to_ZZ("99993749237498237498237493299999999995"));
break;
case 256:
n = to_ZZ_p(to_ZZ("99993749237498237498237493299999937129873912873981273129842343242399999799995"));
break;
case 512:
n = to_ZZ_p(to_ZZ("9999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995"));
break;
case 1024:
n = to_ZZ_p(to_ZZ("99993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995"));
break;
case 2048:
n = to_ZZ_p(to_ZZ("9999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995"));
break;
case 4096:
n = to_ZZ_p(to_ZZ("99993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995"));
break;
case 8192:
n = to_ZZ_p(to_ZZ("9999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995999937492374982374982374932999999371298739128739812731298423432423999997999959999374923749823749823749329999993712987391287398127312984234324239999979999599993749237498237498237493299999937129873912873981273129842343242399999799995"));
break;
default:
n = to_ZZ_p(to_ZZ("9999999999999999995"));
break;
}
for (int i = 1; i <= m.NumRows(); i++) {
for (int j = 1; j <= m.NumCols(); j++) {
m(i,j) = n;
}
}
}
开发者ID:alexgoro,项目名称:garc,代码行数:39,代码来源:Testbench.cpp
示例19: diag
void diag(mat_ZZ_p& X, long n, const ZZ_p& d_in)
{
ZZ_p d = d_in;
X.SetDims(n, n);
long i, j;
for (i = 1; i <= n; i++)
for (j = 1; j <= n; j++)
if (i == j)
X(i, j) = d;
else
clear(X(i, j));
}
开发者ID:av-elier,项目名称:fast-exponentiation-algs,代码行数:13,代码来源:mat_ZZ_p.c
示例20: solve_impl
static
void solve_impl(ZZ_p& d, vec_ZZ_p& X, const mat_ZZ_p& A, const vec_ZZ_p& b, bool trans)
{
long n = A.NumRows();
if (A.NumCols() != n)
LogicError("solve: nonsquare matrix");
if (b.length() != n)
LogicError("solve: dimension mismatch");
if (n == 0) {
set(d);
X.SetLength(0);
return;
}
long i, j, k, pos;
ZZ t1, t2;
ZZ *x, *y;
const ZZ& p = ZZ_p::modulus();
vec_ZZVec M;
sqr(t1, p);
mul(t1, t1, n);
M.SetLength(n);
for (i = 0; i < n; i++) {
M[i].SetSize(n+1, t1.size());
if (trans)
for (j = 0; j < n; j++) M[i][j] = rep(A[j][i]);
else
for (j = 0; j < n; j++) M[i][j] = rep(A[i][j]);
M[i][n] = rep(b[i]);
}
ZZ det;
set(det);
for (k = 0; k < n; k++) {
pos = -1;
for (i = k; i < n; i++) {
rem(t1, M[i][k], p);
M[i][k] = t1;
if (pos == -1 && !IsZero(t1)) {
pos = i;
}
}
if (pos != -1) {
if (k != pos) {
swap(M[pos], M[k]);
NegateMod(det, det, p);
}
MulMod(det, det, M[k][k], p);
// make M[k, k] == -1 mod p, and make row k reduced
InvMod(t1, M[k][k], p);
NegateMod(t1, t1, p);
for (j = k+1; j <= n; j++) {
rem(t2, M[k][j], p);
MulMod(M[k][j], t2, t1, p);
}
for (i = k+1; i < n; i++) {
// M[i] = M[i] + M[k]*M[i,k]
t1 = M[i][k]; // this is already reduced
x = M[i].elts() + (k+1);
y = M[k].elts() + (k+1);
for (j = k+1; j <= n; j++, x++, y++) {
// *x = *x + (*y)*t1
mul(t2, *y, t1);
add(*x, *x, t2);
}
}
}
else {
clear(d);
return;
}
}
X.SetLength(n);
for (i = n-1; i >= 0; i--) {
clear(t1);
for (j = i+1; j < n; j++) {
mul(t2, rep(X[j]), M[i][j]);
add(t1, t1, t2);
}
sub(t1, t1, M[i][n]);
//.........这里部分代码省略.........
开发者ID:tell,项目名称:ntl-unix,代码行数:101,代码来源:mat_ZZ_p.cpp
注:本文中的mat_ZZ_p类示例由纯净天空整理自Github/MSDocs等源码及文档管理平台,相关代码片段筛选自各路编程大神贡献的开源项目,源码版权归原作者所有,传播和使用请参考对应项目的License;未经允许,请勿转载。 |
请发表评论