Home
last modified time | relevance | path

Searched +defs:M +defs:sol +defs:s (Results 1 – 25 of 131) sorted by relevance

123456

/dports/math/gsl/gsl-2.7/linalg/
H A Dtest_qrc.c34 int s = 0; in test_QRc_decomp_eps() local
35 const size_t M = m->size1; in test_QRc_decomp_eps() local
80 int s = 0; in test_QRc_decomp() local
81 size_t N, M; in test_QRc_decomp() local
104 int s = 0; in test_QRc_solve_eps() local
105 const size_t M = A->size1; in test_QRc_solve_eps() local
139 int s = 0; in test_QRc_solve() local
167 const size_t M = A->size1; in test_QRc_lssolve_eps() local
253 const size_t M = m->size1; in test_QRc_decomp_r_eps() local
327 size_t M, N; in test_QRc_decomp_r() local
[all …]
H A Dtest_lu_band.c34 int s = 0; in test_LU_band_decomp_eps() local
35 const size_t M = A->size1; in test_LU_band_decomp_eps() local
79 int s = 0; in test_LU_band_decomp() local
82 size_t M, N, p, q; in test_LU_band_decomp() local
108 const gsl_vector * rhs, const gsl_vector * sol, in test_LU_band_solve_eps()
111 int s = 0; in test_LU_band_solve_eps() local
148 int s = 0; in test_LU_band_solve() local
158 gsl_vector_view sol = gsl_vector_subvector(x, 0, N); in test_LU_band_solve() local
H A Dtest_lu.c34 int s = 0; in test_LU_decomp_eps() local
35 const size_t M = m->size1; in test_LU_decomp_eps() local
111 int s = 0; in test_LU_decomp() local
153 test_LU_solve_eps(const gsl_matrix * m, const gsl_vector * rhs, const gsl_vector * sol, const doubl… in test_LU_solve_eps()
155 int s = 0; in test_LU_solve_eps() local
202 int s = 0; in test_LU_solve() local
209 gsl_vector * sol = gsl_vector_alloc(n); in test_LU_solve() local
234 int s = 0; in test_LU_invert_eps() local
274 int s = 0; in test_LU_invert() local
H A Dtest_luc.c34 int s = 0; in test_LUc_decomp_eps() local
35 const size_t M = m->size1; in test_LUc_decomp_eps() local
115 int s = 0; in test_LUc_decomp() local
154 …onst gsl_matrix_complex * m, const gsl_vector_complex * rhs, const gsl_vector_complex * sol, const… in test_LUc_solve_eps()
156 int s = 0; in test_LUc_solve_eps() local
208 int s = 0; in test_LUc_solve() local
215 gsl_vector_complex * sol = gsl_vector_complex_alloc(n); in test_LUc_solve() local
233 int s = 0; in test_LUc_invert_eps() local
276 int s = 0; in test_LUc_invert() local
H A Dtest_qr.c35 const size_t M = m->size1; in test_QR_decomp_dim() local
127 const size_t M = m->size1; in test_QR_decomp_r_eps() local
197 size_t M, N; in test_QR_decomp_r() local
275 size_t M, N; in test_QR_QTmat_r() local
298 test_QR_solve_r_eps(const gsl_matrix * A, const gsl_vector * rhs, const gsl_vector * sol, in test_QR_solve_r_eps()
340 gsl_vector * sol = gsl_vector_alloc(N); in test_QR_solve_r() local
428 size_t M, N; in test_QR_lssolve_r() local
521 size_t M, N; in test_QR_UR_decomp() local
617 size_t M, N; in test_QR_UZ_decomp() local
760 const size_t M = 2 * N; in test_QR_UU_lssolve_eps() local
[all …]
/dports/mail/crm114/crm114-20100106-BlameMichelson.src/
H A Dcrm_pca_lib_fncts.c37 PCA_Solution *run_pca(Matrix *M, Vector *init_pca) { in run_pca()
44 double xbardotp, d, s, del, n; in run_pca() local
45 PCA_Solution *sol; in run_pca() local
173 void pca_solve(Matrix *X, PCA_Solution **sol) { in pca_solve()
271 int pca_classify(Vector *new_ex, PCA_Solution *sol) { in pca_classify()
290 void pca_free_solution(PCA_Solution *sol) { in pca_free_solution()
/dports/astro/celestia-gtk/celestia-1.6.1/src/celengine/
H A Dorbit.cpp55 double M; member
72 double M; member
86 double M; member
92 double s = ecc * sin(x); in operator ()() local
106 double M; member
112 double s = ecc * sinh(x); in operator ()() local
144 Solution sol = solve_iteration_fixed(SolveKeplerFunc1(eccentricity, M), M, 5); in eccentricAnomaly() local
151 Solution sol = solve_iteration_fixed(SolveKeplerFunc2(eccentricity, M), M, 6); in eccentricAnomaly() local
163 Solution sol = solve_iteration_fixed(SolveKeplerLaguerreConway(eccentricity, M), E, 8); in eccentricAnomaly() local
176 Solution sol = solve_iteration_fixed(SolveKeplerLaguerreConwayHyp(eccentricity, M), E, 30); in eccentricAnomaly() local
[all …]
/dports/astro/celestia/celestia-1.6.1/src/celengine/
H A Dorbit.cpp55 double M; member
72 double M; member
86 double M; member
92 double s = ecc * sin(x); in operator ()() local
106 double M; member
112 double s = ecc * sinh(x); in operator ()() local
144 Solution sol = solve_iteration_fixed(SolveKeplerFunc1(eccentricity, M), M, 5); in eccentricAnomaly() local
151 Solution sol = solve_iteration_fixed(SolveKeplerFunc2(eccentricity, M), M, 6); in eccentricAnomaly() local
163 Solution sol = solve_iteration_fixed(SolveKeplerLaguerreConway(eccentricity, M), E, 8); in eccentricAnomaly() local
176 Solution sol = solve_iteration_fixed(SolveKeplerLaguerreConwayHyp(eccentricity, M), E, 30); in eccentricAnomaly() local
[all …]
/dports/misc/elki/elki-release0.7.1-1166-gfb1fffdf3/elki-core-math/src/test/java/de/lmu/ifi/dbs/elki/math/linearalgebra/
H A DLUDecompositionTest.java42 private final static double[][] M = { // field in LUDecompositionTest
132 double[][] M = transpose(new double[][] { { 0., 2., 3. }, { 5., 6., 7. }, { 9., 10., 11. } }); in testJamaExample() local
144 double[][] s = { { 5., 8. }, { 6., 9. } }; in testJamaSolve() local
146 double[][] sol = { { 1 }, { 1 } }; in testJamaSolve() local
162 double[][] M = { // in testWikipediaQR() local
H A DQRDecompositionTest.java39 private static final double[][] M = { // field in QRDecompositionTest
101 …double[][] M = transpose(new double[][] { { 1., 2., 3., 4. }, { 5., 6., 7., 8. }, { 9., 10., 11., … in testJamaExample() local
111 double[][] s = { { 5., 8. }, { 6., 9. } }; in testJamaSolve() local
113 double[][] sol = { { 1 }, { 1 } }; in testJamaSolve() local
/dports/graphics/opencv/opencv-4.5.3/contrib/modules/videostab/src/
H A Dglobal_motion.cpp105 float s = std::sqrt(2.f) / d; in normalizePoints() local
123 Mat_<float> M = Mat::eye(3, 3, CV_32F); in estimateGlobMotionLeastSquaresTranslation() local
167 Mat_<float> sol; in estimateGlobMotionLeastSquaresTranslationAndScale() local
173 Mat_<float> M = Mat::eye(3, 3, CV_32F); in estimateGlobMotionLeastSquaresTranslationAndScale() local
197 Mat_<float> M = Mat::eye(3, 3, CV_32F); in estimateGlobMotionLeastSquaresRotation() local
302 Mat_<float> sol; in estimateGlobMotionLeastSquaresSimilarity() local
341 Mat_<float> sol; in estimateGlobMotionLeastSquaresAffine() local
508 Mat_<float> M; in estimate() local
652 const double *sol = model.getColSolution(); in estimate() local
678 Mat_<float> M(3, 3); in estimate() local
[all …]
/dports/math/gecode/gecode-0916a1a/test/
H A Dfloat.cpp171 TestSpace::TestSpace(TestSpace& s) in TestSpace() function in Test::Float::TestSpace
261 TestSpace::rel(bool sol) { in rel()
270 …TestSpace::assign(const Assignment& a, MaybeType& sol, bool skip, Gecode::Support::RandomGenerator… in assign()
449 #define CHECK_TEST(T,M) \ argument
495 MaybeType sol = solution(a); in run() local
507 TestSpace* s = new TestSpace(arity,dom,step,this); in run() local
539 TestSpace* s = new TestSpace(arity,dom,step,this); in run() local
554 TestSpace* s = new TestSpace(arity,dom,step,this); in run() local
569 TestSpace* s = new TestSpace(arity,dom,step,this); in run() local
586 TestSpace* s = new TestSpace(arity,dom,step,this); in run() local
[all …]
H A Dint.cpp121 TestSpace::TestSpace(TestSpace& s) in TestSpace() function in Test::Int::TestSpace
246 TestSpace::rel(bool sol) { in rel()
439 #define CHECK_TEST(T,M) \ argument
487 bool sol = solution(a); in run() local
496 TestSpace* s = new TestSpace(arity,dom,this); in run() local
528 TestSpace* s = new TestSpace(arity,dom,this); in run() local
543 TestSpace* s = new TestSpace(arity,dom,this); in run() local
1062 TestSpace* s = e_s.next(); in run() local
1088 TestSpace* s = new TestSpace(arity,dom,this); in run() local
1101 TestSpace* s = new TestSpace(arity,dom,this); in run() local
[all …]
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/C3/test/lib_linalg_test/
H A Dlinalg_test.c57 size_t M = 5; in Test_qr() local
91 size_t M = 5; in Test_pinv() local
130 size_t M = 7; in Test_rq_with_rmult() local
168 double s[4]; in Test_svd() local
241 size_t M = 4; in Test_maxvol_rhs() local
330 double * sol = calloc_double(nparam); in Test_linear_ls() local
/dports/math/pari/pari-2.13.3/src/basemath/
H A Dqfsolve.c62 kermodp(GEN M, GEN p, long *d) in kermodp()
123 GEN sol; in qflocalinvariants() local
226 GEN M, R, g, DM, S, dR; in qflllgram_indef() local
434 GEN d, U, Ker, sol, aux, faE, faP; in qfminimize() local
583 GEN m,n, aux,Q1,M, A,B,C; in qfbsqrt() local
592 GEN p = gel(P,i), N, M; in qfbsqrt() local
745 GEN s, H; in qftriv() local
842 GEN solG1, sol, Q, d, dQ, detG2, fam2detG; in qfsolve_i() local
883 long r = signG[1], s = signG[2]; in qfsolve_i() local
987 long s = signe(dQ) == signe(d)? 1: -1; in qfsolve_i() local
[all …]
/dports/science/siconos/siconos-4.4.0/numerics/src/tools/test/
H A Dtest_blas_lapack.c10 #define M 2 macro
68 #define M 6 macro
165 double sol[LDB*NRHS] = {-0.80071403, -0.69524338, 0.59391499, 1.32172561, 0.5657562, in test_dgesv() local
285 #define M 6 macro
305 double s[N], u[LDU*M], vt[LDVT*N]; in test_dgesvd() local
/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/tests/sys/
H A Dsys_EigenSolverSparse.cpp129 EigenSolverSolution<ST,MV> sol = problem->getSolution(); in testStandardBlockDavidsonEigenSolver() local
217 EigenSolverSolution<ST,MV> sol = problem->getSolution(); in testStandardBlockKrylovSchurSolver() local
310 …SmartPtr< const LargeMatrixAdapter<LargeMatrix<ST>, ST> > M(new LargeMatrixAdapter<LargeMatrix<ST>… in testGeneralizedBlockDavidsonEigenSolver() local
349 EigenSolverSolution<ST,MV> sol = problem->getSolution(); in testGeneralizedBlockDavidsonEigenSolver() local
400 …SmartPtr< const LargeMatrixAdapter<LargeMatrix<ST>, ST> > M(new LargeMatrixAdapter<LargeMatrix<ST>… in testGeneralizedBlockKrylovSchurEigenSolver() local
433 EigenSolverSolution<ST,MV> sol = problem->getSolution(); in testGeneralizedBlockKrylovSchurEigenSolver() local
478 std::stringstream s; in Laplace_Neumann_Eigen_Pk() local
514 TermMatrix M(muv, "M"); in Laplace_Neumann_Eigen_Pk() local
/dports/math/cddlib/cddlib-0.94l/lib-src/
H A Dcddlp.c672 dd_rowrange r, dd_colrange s) in dd_TableauEntry()
690 colset NopivotCol,dd_rowrange *r,dd_colrange *s, in dd_SelectPivot2()
844 dd_rowrange *r,dd_colrange *s, in dd_SelectCrissCrossPivot()
1026 dd_colrange j,s; in dd_FindLPBasis() local
1095 dd_colrange j,s; in dd_FindLPBasis2() local
1416 dd_colrange j,s; in dd_DualSimplexMaximize() local
1598 dd_colrange s; in dd_CrissCrossMaximize() local
1677 mytype *optvalue,dd_Arow sol,dd_Arow dsol,dd_rowset posset, dd_colindex nbindex, in dd_SetSolutions()
3582 mytype *optvalue,dd_Arow sol,dd_Arow dsol,dd_rowset posset, ddf_colindex nbindex, in dd_BasisStatusMaximize()
3598 dd_colrange s,senew,j; in dd_BasisStatusMaximize() local
[all …]
/dports/math/sympol/SymPol-0.1.9/external/cddlib-094f/
H A Dcddlp_f.c672 ddf_rowrange r, ddf_colrange s) in ddf_TableauEntry()
690 colset NopivotCol,ddf_rowrange *r,ddf_colrange *s, in ddf_SelectPivot2()
844 ddf_rowrange *r,ddf_colrange *s, in ddf_SelectCrissCrossPivot()
1026 ddf_colrange j,s; in ddf_FindLPBasis() local
1095 ddf_colrange j,s; in ddf_FindLPBasis2() local
1416 ddf_colrange j,s; in ddf_DualSimplexMaximize() local
1598 ddf_colrange s; in ddf_CrissCrossMaximize() local
1677 myfloat *optvalue,ddf_Arow sol,ddf_Arow dsol,ddf_rowset posset, ddf_colindex nbindex, in ddf_SetSolutions()
3581 myfloat *optvalue,ddf_Arow sol,ddf_Arow dsol,ddf_rowset posset, ddf_colindex nbindex, in ddf_BasisStatusMaximize()
3597 ddf_colrange s,senew,j; in ddf_BasisStatusMaximize() local
[all …]
H A Dcddlp.c671 dd_rowrange r, dd_colrange s) in dd_TableauEntry()
689 colset NopivotCol,dd_rowrange *r,dd_colrange *s, in dd_SelectPivot2()
843 dd_rowrange *r,dd_colrange *s, in dd_SelectCrissCrossPivot()
1025 dd_colrange j,s; in dd_FindLPBasis() local
1094 dd_colrange j,s; in dd_FindLPBasis2() local
1415 dd_colrange j,s; in dd_DualSimplexMaximize() local
1597 dd_colrange s; in dd_CrissCrossMaximize() local
1676 mytype *optvalue,dd_Arow sol,dd_Arow dsol,dd_rowset posset, dd_colindex nbindex, in dd_SetSolutions()
3580 mytype *optvalue,dd_Arow sol,dd_Arow dsol,dd_rowset posset, ddf_colindex nbindex, in dd_BasisStatusMaximize()
3596 dd_colrange s,senew,j; in dd_BasisStatusMaximize() local
[all …]
/dports/devel/taskflow/taskflow-3.2.0/sandbox/cublas_unittests/
H A Dlevel3.cu681 for(size_t s=0; s<S; s++) { in gemm_batched() local
765 for(size_t s=0; s<S; s++) { in gemm_batched() local
821 for(size_t s=0; s<S; s++) { in gemm_batched_nn() local
855 for(size_t s=0; s<S; s++) { in gemm_batched_tn() local
889 for(size_t s=0; s<S; s++) { in gemm_batched_nt() local
924 for(size_t s=0; s<S; s++) { in gemm_batched_tt() local
1164 for(size_t s=0; s<S; s++) { in gemm_strided_batched_nn() local
1199 for(size_t s=0; s<S; s++) { in gemm_strided_batched_tn() local
1234 for(size_t s=0; s<S; s++) { in gemm_strided_batched_nt() local
1270 for(size_t s=0; s<S; s++) { in gemm_strided_batched_tt() local
[all …]
/dports/deskutils/calendar/calendar-0.9.2/
H A Dsunpos.c58 comp(char *s, double v, double c) in comp()
105 double ZJ, D, T, M, epsilon, lambda, alpha, HA, UTHM; in sunpos() local
189 #define SHOUR(s) ((s) / 3600) argument
190 #define SMIN(s) (((s) % 3600) / 60) argument
191 #define SSEC(s) ((s) % 60) argument
221 int dial, s; in fequinoxsolstice() local
445 int eq[2], sol[2]; in main() local
/dports/math/giacxcas/CoCoALib-0.99700/src/AlgebraicCore/
H A DTmpLDP.C191 long M = A->size1, N = A->size2, K = B->size2; in myMul() local
319 MatrixView& M, in UpdateMatricesNBM()
356 matrix AbsMatrix(ConstMatrixView M) in AbsMatrix()
378 ConstMatrixView M, in NBMBound()
420 ConstMatrixView M, in CheckNBMBound()
456 long M = m->size1, N = m->size2; in NumericalRank() local
520 long M = m->size1, N = m->size2; in NumericalRank() local
773 void NormalFlow(gsl_vector *sol, in NormalFlow()
875 void RootFindingAlgorithm(vector<RingElem>& sol, in RootFindingAlgorithm()
962 int s; in RootFindingAlgorithm() local
[all …]
/dports/math/cocoalib/CoCoALib-0.99712/src/AlgebraicCore/
H A DTmpLDP.C191 long M = A->size1, N = A->size2, K = B->size2; in myMul() local
319 MatrixView& M, in UpdateMatricesNBM()
356 matrix AbsMatrix(ConstMatrixView M) in AbsMatrix()
378 ConstMatrixView M, in NBMBound()
420 ConstMatrixView M, in CheckNBMBound()
456 long M = m->size1, N = m->size2; in NumericalRank() local
520 long M = m->size1, N = m->size2; in NumericalRank() local
773 void NormalFlow(gsl_vector *sol, in NormalFlow()
875 void RootFindingAlgorithm(vector<RingElem>& sol, in RootFindingAlgorithm()
962 int s; in RootFindingAlgorithm() local
[all …]
/dports/math/giacxcas/giac-1.6.0/src/
H A Dplot3d.cc144 gen M,N,coeff; in _plan() local
419 gen M,N; in _perpendiculaire_commune() local
459 gen s; // sign in polyedre() local
559 int s=int(w.size()); in _prisme() local
822 gen s[12]; in _icosaedre() local
901 gen s[20]; in _dodecaedre() local
948 gen M=elem._VECTptr->back(); in rotation3d() local
1220 gen M(_point(A+t*v,contextptr)); in interdroitehyperplan() local
1304 gen sol=inter_solve(gen(makevecteur(veq,makevecteur(t,u,v)),_SEQ__VECT),contextptr); in inter2hypersurface() local
1370 vecteur sol; in interhypersurfacecurve() local
[all …]

123456