Home
last modified time | relevance | path

Searched refs:bnrm2 (Results 1 – 25 of 50) sorted by relevance

12

/dports/science/siconos/siconos-4.4.0/externals/netlib/dctemplates/
H A DCheby.c127 static doublereal beta, bnrm2; local
194 bnrm2 = dnrm2_(n, &b[1], &c__1);
195 if(bnrm2 == 0.)
197 bnrm2 = 1.;
238 *resid = dnrm2_(n, &work[r * work_dim1 + 1], &c__1) / bnrm2;
H A DCG.c127 static doublereal bnrm2; local
188 bnrm2 = dnrm2_(n, &b[1], &c__1);
189 if(bnrm2 == 0.)
191 bnrm2 = 1.;
242 *resid = dnrm2_(n, &work[r * work_dim1 + 1], &c__1) / bnrm2;
H A DBiCGSTAB.c145 static doublereal omegatol, bnrm2; local
219 bnrm2 = dnrm2_(n, &b[1], &c__1);
220 if(bnrm2 == 0.)
222 bnrm2 = 1.;
276 *resid = dnrm2_(n, &work[s * work_dim1 + 1], &c__1) / bnrm2;
301 *resid = dnrm2_(n, &work[r * work_dim1 + 1], &c__1) / bnrm2;
H A DSOR.c132 static doublereal bnrm2; local
204 bnrm2 = dnrm2_(n, &b[1], &c__1);
205 if(bnrm2 == 0.)
207 bnrm2 = 1.;
H A DBiCG.c171 static doublereal bnrm2; local
242 bnrm2 = dnrm2_(n, &b[1], &c__1);
243 if(bnrm2 == 0.)
245 bnrm2 = 1.;
306 *resid = dnrm2_(n, &work[r * work_dim1 + 1], &c__1) / bnrm2;
H A DGMRES.c136 static doublereal bnrm2; local
211 bnrm2 = dnrm2_(n, &b[1], &c__1);
212 if(bnrm2 == 0.)
214 bnrm2 = 1.;
216 if(dnrm2_(n, &work[r * work_dim1 + 1], &c__1) / bnrm2 < tol)
289 *resid = (d__1 = work[i + 1 + s * work_dim1], abs(d__1)) / bnrm2;
320 *resid = work[i + 1 + s * work_dim1] / bnrm2;
H A DCGS.c137 static doublereal bnrm2; local
207 bnrm2 = dnrm2_(n, &b[1], &c__1);
208 if(bnrm2 == 0.)
210 bnrm2 = 1.;
301 *resid = dnrm2_(n, &work[r * work_dim1 + 1], &c__1) / bnrm2;
H A DQMR.c190 static doublereal gammatol, deltatol, bnrm2; local
276 bnrm2 = dnrm2_(n, &b[1], &c__1);
277 if(bnrm2 == 0.)
279 bnrm2 = 1.;
447 *resid = dnrm2_(n, &work[r * work_dim1 + 1], &c__1) / bnrm2;
/dports/math/lis/lis-2.0.30/src/solver/
H A Dlis_solver_jacobi.c119 LIS_REAL bnrm2,nrm2,tol; in lis_jacobi() local
138 lis_vector_nrm2(b,&bnrm2); in lis_jacobi()
139 bnrm2 = 1.0 / bnrm2; in lis_jacobi()
158 nrm2 = nrm2 * bnrm2; in lis_jacobi()
H A Dlis_solver_sor.c130 LIS_REAL bnrm2, nrm2, tol; in lis_sor() local
153 lis_vector_nrm2(b,&bnrm2); in lis_sor()
154 bnrm2 = 1.0 / bnrm2; in lis_sor()
185 nrm2 = nrm2 * bnrm2; in lis_sor()
H A Dlis_solver_gs.c119 LIS_REAL bnrm2, nrm2, tol; in lis_gs() local
141 lis_vector_nrm2(b,&bnrm2); in lis_gs()
142 bnrm2 = 1.0 / bnrm2; in lis_gs()
172 nrm2 = nrm2 * bnrm2; in lis_gs()
H A Dlis_solver_cg.c137 LIS_REAL bnrm2, nrm2, tol; in lis_cg() local
160 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_cg()
248 LIS_REAL bnrm2, nrm2, tol; in lis_cg_quad() local
278 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_cg_quad()
367 LIS_REAL bnrm2, nrm2, tol, tol2; in lis_cg_switch() local
401 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_cg_switch()
479 lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2); in lis_cg_switch()
640 LIS_REAL bnrm2, nrm2, tol; in lis_cocg() local
829 LIS_REAL bnrm2, nrm2, tol; in lis_cr() local
953 LIS_REAL bnrm2, nrm2, tol; in lis_cr_quad() local
[all …]
H A Dlis_solver_bicg.c145 LIS_REAL bnrm2, nrm2, tol; in lis_bicg() local
174 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_bicg()
289 LIS_REAL bnrm2, nrm2, tol; in lis_bicg_quad() local
323 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_bicg_quad()
440 LIS_REAL bnrm2, nrm2, tol, tol2; in lis_bicg_switch() local
479 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_bicg_switch()
589 lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2); in lis_bicg_switch()
795 LIS_REAL bnrm2, nrm2, tol; in lis_bicr() local
824 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_bicr()
938 LIS_REAL bnrm2, nrm2, tol; in lis_bicr_quad() local
[all …]
H A Dlis_solver_cgs.c141 LIS_REAL bnrm2, nrm2, tol; in lis_cgs() local
170 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_cgs()
288 LIS_REAL bnrm2, nrm2, tol; in lis_cgs_quad() local
328 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_cgs_quad()
450 LIS_REAL bnrm2, nrm2, tol, tol2; in lis_cgs_switch() local
493 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_cgs_switch()
605 lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2); in lis_cgs_switch()
812 LIS_REAL bnrm2, nrm2, tol; in lis_crs() local
840 if( lis_solver_get_initial_residual(solver,NULL,NULL,r,&bnrm2) ) in lis_crs()
950 LIS_REAL bnrm2, nrm2, tol; in lis_crs_quad() local
[all …]
/dports/devel/blitz/blitz-1.0.2/linalg/
H A DmyIterative.py29 bnrm2 = norm(b)
30 if ( bnrm2 == 0.0 ):
31 bnrm2 = 1.0
35 error = norm( r ) / bnrm2
83 error = abs(s[i+1]) / bnrm2
99 error = abs(s[i+1]) / bnrm2 # check convergence
/dports/science/apbs/apbs-pdb2pqr-apbs-1.5-102-g500c1473/apbs/externals/bem/src/
H A Dgmres.c159 static doublereal bnrm2; local
238 bnrm2 = dnrm2_(n, &b[1], &c__1);
239 if (bnrm2 == 0.) {
240 bnrm2 = 1.;
242 if (dnrm2_(n, &work[r * work_dim1 + 1], &c__1) / bnrm2 < tol) {
328 *resid = (d__1 = work[i + 1 + s * work_dim1], abs(d__1)) / bnrm2;
361 *resid = work[i + 1 + s * work_dim1] / bnrm2;
/dports/science/py-scipy/scipy-1.7.1/scipy/sparse/linalg/isolve/
H A Diterative.py78 def _get_atol(tol, atol, bnrm2, get_residual, routine_name): argument
111 if bnrm2 == 0:
114 return tol * float(bnrm2)
116 return max(float(atol), tol * float(bnrm2))
568 bnrm2 = np.linalg.norm(b)
571 atol = _get_atol(tol, atol, bnrm2, get_residual, 'gmres')
575 if bnrm2 == 0:
581 ptol = Mb_nrm2 * min(ptol_max_factor, atol / bnrm2)
608 callback(presid / bnrm2)
626 callback(presid / bnrm2)
/dports/math/scilab/scilab-6.1.1/scilab/modules/sparse/macros/
H A D%pcg.sci64 bnrm2 = norm(%b);
66 printf(gettext("Norm of right-hand side : %s\n"), string(bnrm2));
68 if (bnrm2 == 0) then
84 resNorm = norm(r) / bnrm2;
146 resNorm = norm(r) / bnrm2;
H A D%bicgstab.sci53 bnrm2 = norm(%b);
55 printf(gettext("Norm of right-hand side : %s\n"), string(bnrm2));
57 if (bnrm2 == 0) then
75 resNorm = norm(r) / bnrm2;
143 resNorm = norm(s) / bnrm2;
183 resNorm = norm(r) / bnrm2;
H A D%bicg.sci53 bnrm2 = norm(%b);
55 printf(gettext("Norm of right-hand side : %s\n"), string(bnrm2));
57 if (bnrm2 == 0) then
75 resNorm = norm(r) / bnrm2;
170 resNorm = norm(r) / bnrm2;
H A D%cgs.sci53 bnrm2 = norm(%b);
55 printf(gettext("Norm of right-hand side : %s\n"), string(bnrm2));
57 if (bnrm2 == 0) then
75 resNorm = norm(r) / bnrm2;
175 resNorm = norm(r) / bnrm2;
/dports/math/parmetis/parmetis-4.0.3/libparmetis/
H A Ddiffutil.c183 real_t alpha, beta, rho, rho_1 = -1.0, error, bnrm2, tmp; in ConjGrad2() local
212 bnrm2 = rnorm2(n, b, 1); in ConjGrad2()
213 if (bnrm2 > 0.0) { in ConjGrad2()
214 error = rnorm2(n, r, 1) / bnrm2; in ConjGrad2()
244 error = rnorm2(n, r, 1) / bnrm2; in ConjGrad2()
/dports/math/libmesh/libmesh-1.6.2/contrib/parmetis/libparmetis/
H A Ddiffutil.c183 real_t alpha, beta, rho, rho_1 = -1.0, error, bnrm2, tmp; in ConjGrad2() local
212 bnrm2 = rnorm2(n, b, 1); in ConjGrad2()
213 if (bnrm2 > 0.0) { in ConjGrad2()
214 error = rnorm2(n, r, 1) / bnrm2; in ConjGrad2()
244 error = rnorm2(n, r, 1) / bnrm2; in ConjGrad2()
/dports/graphics/pfstools/pfstools-2.1.0/src/tmo/mantiuk06/
H A Dcontrast_domain.cpp669 const float bnrm2 = matrix_DotProduct(n, b, b); in linbcg() local
683 const float percent_sf = 100.0f/logf(tol2*bnrm2/ierr2); in linbcg()
777 if(err2/bnrm2 < tol2) in linbcg()
788 if (err2/bnrm2 > tol2) in linbcg()
794 …converged (hit maximum iterations), error = %g (should be below %g).\n", sqrtf(err2/bnrm2), tol); in linbcg()
796 …ng: Not converged (going unstable), error = %g (should be below %g).\n", sqrtf(err2/bnrm2), tol); in linbcg()
827 const float bnrm2 = matrix_DotProduct(n, b, b); in lincg() local
842 const float percent_sf = 100.0f/logf(tol2*bnrm2/irdotr); in lincg()
894 if(rdotr/bnrm2 < tol2) in lincg()
933 if (rdotr/bnrm2 > tol2) in lincg()
[all …]
/dports/graphics/luminance-qt5/luminance-hdr-2.6.1.1/src/TonemappingOperators/mantiuk06/
H A Dcontrast_domain.cpp137 const float bnrm2 = utils::dotProduct(b.data(), n); in lincg() local
152 const float percent_sf = (100.0f - phvalue) / std::log(tol2 * bnrm2 / irdotr); in lincg()
196 if (rdotr_curr / bnrm2 < tol2) break; in lincg()
227 if (rdotr_curr / bnrm2 > tol2) { in lincg()
235 << std::sqrt(rdotr_curr / bnrm2) << " (should be below " in lincg()
241 << std::sqrt(rdotr_curr / bnrm2) << " (should be below " in lincg()

12