Home
last modified time | relevance | path

Searched +defs:M +defs:rk (Results 1 – 25 of 122) sorted by relevance

12345

/dports/math/cocoalib/CoCoALib-0.99712/src/AlgebraicCore/
H A DMatrixOps-rank.C35 long rk(const ConstMatrixView& M) in rk() function
75 long RankByGauss(std::vector<long>& IndepRows, ConstMatrixView M) in RankByGauss()
H A DMatrixFp.C57 MatrixFp::MatrixFp(const ConstMatrixView& M): in MatrixFp()
137 long rk(LinSolver& LS) { if (LS.myRank < 0) LS.SolveByGauss(); return LS.myRank; } in rk() function
140 LinSolver::LinSolver(/*const SmallFpImpl& Modp,*/ const MatrixFp& M, const MatrixFp& rhs): in LinSolver()
259 matrix LinSolveFp(ConstMatrixView M, ConstMatrixView rhs) in LinSolveFp()
508 long/*SmallFpImpl::value*/ det(MatrixFp& M) in det()
H A DMatrixView.C150 ConstMatrixView transpose(ConstMatrixView M) in transpose()
198 TransposeMatImpl::TransposeMatImpl(MatrixView M): in TransposeMatImpl()
313 MatrixView transpose(MatrixView M) in transpose()
571 MatrixView ColMat(MatrixView M, long col) in ColMat()
577 ConstMatrixView ColMat(ConstMatrixView M, long col) in ColMat()
583 MatrixView RowMat(MatrixView M, long row) in RowMat()
589 ConstMatrixView RowMat(ConstMatrixView M, long row) in RowMat()
919 bool IsConstDiagMatImpl(ConstMatrixView M) in IsConstDiagMatImpl()
1043 long rk=0; in myRank() local
1102 bool IsDiagMatImpl(ConstMatrixView M) in IsDiagMatImpl()
[all …]
/dports/math/optpp/optpp-2.4/src/GSS/
H A DGenSetBase.C25 bool GenSetBase::generateAll(Matrix& M, ColumnVector& X, double D){ in generateAll()
47 bool GenSetBase::generateAllActive(Matrix& M, ColumnVector& X, double D){ in generateAllActive()
115 double rk; in pllMesh() local
116 Matrix M, A, B, C; in pllMesh() local
/dports/math/barvinok/barvinok-0.41.5/polylib/source/kernel/
H A Dcompress_parms.c56 Matrix * int_ker(Matrix * M) { in int_ker()
58 int i, j, rk; in int_ker() local
121 int rk = A->NbRows; in linearInter() local
182 Matrix * Hm, *H=NULL, *U, *Q, *M=NULL, *C=NULL, *Hi; in Equalities_integerSolution() local
186 unsigned int rk; in Equalities_integerSolution() local
335 void Constraints_removeElimCols(Matrix * M, unsigned int nbVars, in Constraints_removeElimCols()
386 void Constraints_fullDimensionize(Matrix ** M, Matrix ** C, Matrix ** VL, in Constraints_fullDimensionize()
548 Matrix * affine_periods(Matrix * M, Matrix * d) { in affine_periods()
654 Matrix * M = (*M1); in Constraints_Remove_parm_eqs() local
862 Matrix * M = Polyhedron2Constraints((*P)); in Polyhedron_Remove_parm_eqs() local
[all …]
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/OPTPP/src/GSS/
H A DGenSetBase.C25 bool GenSetBase::generateAll(SerialDenseMatrix<int,double>& M, SerialDenseVector<int,double>& X, do… in generateAll()
51 bool GenSetBase::generateAllActive(SerialDenseMatrix<int,double>& M, SerialDenseVector<int,double>&… in generateAllActive()
121 double rk; in pllMesh() local
122 SerialDenseMatrix<int,double> M, A, B; in pllMesh() local
/dports/finance/quantlib/QuantLib-1.20/ql/experimental/math/
H A Dexpm.cpp54 Disposable<Matrix> Expm(const Matrix& M, Real t, Real tol) { in Expm()
58 AdaptiveRungeKutta<> rk(tol); in Expm() local
/dports/math/libnormaliz/normaliz-3.9.0/source/libnormaliz/
H A Dmatrix.cpp476 Matrix<Integer> M(size, nc); in submatrix() local
514 Matrix<Integer> M(size, nc); in submatrix() local
557 Matrix<Integer> M(nr, nc); in selected_columns_first() local
1863 size_t rk; in row_echelon() local
1933 size_t rk; in row_echelon() local
2410 size_t rk = 0; in max_rank_submatrix_lex_inner() local
2491 size_t rk; in solve_destructive_inner() local
2818 Matrix<Integer> M(nr, nc + Right_side.nc); in solve() local
2842 Matrix<Integer> M(nr, nc + Right_side.nc); in bundle_matrices() local
3075 size_t rk; in row_echelon_reduce() local
[all …]
/dports/math/linbox/linbox-1.6.3/linbox/solutions/
H A Drank.inl96 const Method::Wiedemann &M)
133 int nbperm = 0; size_t rk; local
275 int nbperm = 0; size_t rk; local
391 const Method::SparseElimination &M)
403 const Method::SparseElimination &M)
416 const Method::DenseElimination &M)
461 const MyMethod &M)
486 const Method::SparseElimination &M)
562 const Method &M)
613 const Method::DenseElimination &M)
[all …]
/dports/math/singular/Singular-Release-4-2-1/factory/
H A DcfModGcd.cc525 CFMap M,N; in modGCDFq() local
919 CFMap M,N; in modGCDGF() local
1269 CFMap M,N; in modGCDFp() local
1690 readOffSolution (const CFMatrix& M, const long rk) in readOffSolution()
1771 long rk= gauss (*NTLN); in gaussianElimFp() local
1824 long rk= gauss (*NTLN); in gaussianElimFq() local
1868 long rk= gauss (*NTLN); in solveSystemFp() local
1928 long rk= gauss (*NTLN); in solveSystemFq() local
2219 CFMap M,N; in monicSparseInterpol() local
2503 CFMap M,N; in nonMonicSparseInterpol() local
[all …]
/dports/textproc/R-cran-openxlsx/openxlsx/src/
H A Dwrite_data.cpp188 size_t rk = int(row[1]) - ra + 1; in build_cell_merges() local
193 CharacterVector M(ck*rk); in build_cell_merges() local
/dports/math/eclib/eclib-20210318/libsrc/
H A Dmat.cc672 long& rk, long& ny, scalar& d, int method) in echelon()
802 long& rk, long& ny, scalar& d) in echelon0()
935 long rk,nr,nc,r,c,r2,r3,rmin; in rank() local
1079 long& rk, long& ny, scalar& d) in echelonl()
1269 long& rk, long& ny, scalar& d, scalar pr) in echelonp()
1376 long& rk, long& ny, scalar pr) in echmodp()
1508 void mod_mat_from_mat(mod_mat& A, const mat& M, scalar pr) in mod_mat_from_mat()
1528 mat M(nr, nc); in mat_from_mod_mat() local
1536 mat ref_via_flint(const mat& M, scalar pr) in ref_via_flint()
1568 mat ref_via_flint(const mat& M, vec& pcols, vec& npcols, in ref_via_flint()
[all …]
/dports/math/giacxcas/CoCoALib-0.99700/src/AlgebraicCore/
H A DMatrixOps.C365 RingElem det(const ConstMatrixView& M) in det()
384 long rk(const ConstMatrixView& M) in rk() function
392 matrix inverse(ConstMatrixView M) in inverse()
400 matrix adj(ConstMatrixView M) in adj()
453 matrix LinKer(ConstMatrixView M) in LinKer()
610 RingElem det2x2(ConstMatrixView M) in det2x2()
621 RingElem det3x3(ConstMatrixView M) in det3x3()
634 RingElem det4x4(ConstMatrixView M) in det4x4()
662 RingElem det5x5(ConstMatrixView M) in det5x5()
709 RingElem DetDirect(ConstMatrixView M) in DetDirect()
[all …]
H A DMatrixFp.C57 MatrixFp::MatrixFp(const ConstMatrixView& M): in MatrixFp()
137 long rk(LinSolver& LS) { if (LS.myRank < 0) LS.SolveByGauss(); return LS.myRank; } in rk() function
140 LinSolver::LinSolver(/*const SmallFpImpl& Modp,*/ const MatrixFp& M, const MatrixFp& rhs): in LinSolver()
259 matrix LinSolveFp(ConstMatrixView M, ConstMatrixView rhs) in LinSolveFp()
508 long/*SmallFpImpl::value*/ det(MatrixFp& M) in det()
H A DMatrixView.C150 ConstMatrixView transpose(ConstMatrixView M) in transpose()
198 TransposeMatImpl::TransposeMatImpl(MatrixView M): in TransposeMatImpl()
313 MatrixView transpose(MatrixView M) in transpose()
571 MatrixView ColMat(MatrixView M, long col) in ColMat()
577 ConstMatrixView ColMat(ConstMatrixView M, long col) in ColMat()
583 MatrixView RowMat(MatrixView M, long row) in RowMat()
589 ConstMatrixView RowMat(ConstMatrixView M, long row) in RowMat()
919 bool IsConstDiagMatImpl(ConstMatrixView M) in IsConstDiagMatImpl()
1043 long rk=0; in myRank() local
1102 bool IsDiagMatImpl(ConstMatrixView M) in IsDiagMatImpl()
[all …]
/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/tests/unit/
H A Dunit_Matrix.cpp264 Matrix<real_t> M(3,2,0.), Mt(2,3,0.), N(3,2,0.), Nt(2,3,0.); in unit_Matrix() local
320 number_t rk=5; in unit_Matrix() local
/dports/astro/xplanet/xplanet-1.3.1/src/libephemeris/libmoons/
H A Dsaturn.cpp153 const double M = lambda - lp; in satsat() local
235 const double rk = elem[2]; in satsat() local
/dports/science/qmcpack/qmcpack-3.11.0/src/AFQMC/Utilities/
H A DUtils.hpp69 void parallel_inplace_merge(int np, int rk, Iter* beg, Iter* mid, Iter* end, MPI_Comm comm, Compare… in parallel_inplace_merge()
322 void sampleGaussianFields(Mat&& M, RandomNumberGenerator_& rng) in sampleGaussianFields()
/dports/math/scilab/scilab-6.1.1/scilab/modules/spreadsheet/src/c/
H A Dxls.c51 void xls_read(int *fd, int *cur_pos, double **data, int **chainesind, int *N, int *M, int *err) in xls_read()
508 static double NumFromRk2(long rk) in NumFromRk2()
/dports/math/R/R-4.1.2/src/library/stats/R/
H A Dmlm.R131 T = Thin.row(proj(M)-proj(X)), argument
190 T = Thin.row(proj(M)-proj(X)), argument
219 T = Thin.row(proj(M) - proj(X)), argument
261 rk <- object$rank functionVar
412 T = Thin.row(proj(M)-proj(X)), argument
/dports/math/libRmath/R-4.1.1/src/library/stats/R/
H A Dmlm.R131 T = Thin.row(proj(M)-proj(X)), argument
190 T = Thin.row(proj(M)-proj(X)), argument
219 T = Thin.row(proj(M) - proj(X)), argument
261 rk <- object$rank functionVar
412 T = Thin.row(proj(M)-proj(X)), argument
/dports/math/libsemigroups/libsemigroups-1.3.7/include/libsemigroups/
H A Duf.hpp210 rank_type rk = (j == i ? 0 : 1); in compress() local
442 size_type const M = this->size(); in resize() local
/dports/misc/vxl/vxl-3.3.2/core/vpgl/algo/
H A Dvpgl_camera_compute.cxx221 for (unsigned rk = 0; rk < 3; ++rk) in compute() local
241 vnl_matrix<double> M = v2k * D; in compute() local
/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/tools/
H A DvisuTermVec.m630 rk = 1; variable
632 M = ones(nbtet,1)*gcn(nt,:); variable
/dports/math/cado-nfs/cado-nfs-f4284e2391121b2bfb97bc4880b6273c7250dc2f/utils/
H A Dbadideals.cpp125 cxx_mpz_mat M; member
424 cxx_mpz badideal::r_from_rk(cxx_mpz const & p, int k, cxx_mpz const & rk) in r_from_rk()

12345