Home
last modified time | relevance | path

Searched refs:betai (Results 1 – 25 of 77) sorted by relevance

1234

/dports/science/tinker/tinker/source/
H A Dinvbeta.f33 real*8 betai,gammln local
36 external betai
72 error = betai(a,b,x) - y
90 error = betai(a,b,x) - y
115 function betai (a,b,x) function
117 real*8 betai,a,b,x local
126 betai = 0.0d0
128 betai = 1.0d0
133 betai = (bt/a) * betacf (a,b,x)
135 betai = 1.0d0 - (bt/b) * betacf (b,a,1.0d0-x)
/dports/math/openblas/OpenBLAS-0.3.18/kernel/generic/
H A Dzgeadd.c31 …s, FLOAT alphar, FLOAT alphai, FLOAT *a, BLASLONG lda, FLOAT betar, FLOAT betai , FLOAT *b, BLASLO… in CNAME() argument
49 SCAL_K(rows, 0,0, betar, betai, bptr, 1, NULL, 0,NULL,0); in CNAME()
57 AXPBY_K(rows, alphar, alphai, aptr, 1, betar, betai, bptr, 1); in CNAME()
/dports/textproc/py-nltk/nltk-3.4.1/nltk/metrics/
H A Dscores.py18 from scipy.stats.stats import betai
20 betai = None variable
204 if betai:
206 print("prob(phi<=%f): %f" % (phi, betai(c, shuffles, phi)))
/dports/math/osi/Osi-0.108.6/Osi/src/OsiCommonTest/
H A DOsiSimplexAPITest.cpp197 double *betai = new double[m]; in testBInvRow() local
200 CoinFillN(betai, m, COIN_DBL_MAX); in testBInvRow()
202 OSIUNITTEST_CATCH_ERROR(si->getBInvRow(i, betai), {}, solverName, "testBInvRow"); in testBInvRow()
204 basisMtx->transposeTimes(betai, ei); in testBInvRow()
210 delete[] betai; in testBInvRow()
315 double *betai = new double[m]; in testBInvARow() local
319 CoinFillN(betai, m, COIN_DBL_MAX); in testBInvARow()
320 OSIUNITTEST_CATCH_ERROR(si->getBInvARow(i, abari, betai), {}, solverName, "testBInvARow"); in testBInvARow()
334 basisMtx->transposeTimes(betai, ei); in testBInvARow()
348 delete[] betai; in testBInvARow()
/dports/math/clp/Clp-1.17.3/Osi/src/OsiCommonTest/
H A DOsiSimplexAPITest.cpp197 double *betai = new double[m]; in testBInvRow() local
200 CoinFillN(betai, m, COIN_DBL_MAX); in testBInvRow()
202 OSIUNITTEST_CATCH_ERROR(si->getBInvRow(i, betai), {}, solverName, "testBInvRow"); in testBInvRow()
204 basisMtx->transposeTimes(betai, ei); in testBInvRow()
210 delete[] betai; in testBInvRow()
315 double *betai = new double[m]; in testBInvARow() local
319 CoinFillN(betai, m, COIN_DBL_MAX); in testBInvARow()
320 OSIUNITTEST_CATCH_ERROR(si->getBInvARow(i, abari, betai), {}, solverName, "testBInvARow"); in testBInvARow()
334 basisMtx->transposeTimes(betai, ei); in testBInvARow()
348 delete[] betai; in testBInvARow()
/dports/math/gsl/gsl-2.7/multifit_nlinear/
H A Dcommon.c101 double betai = gsl_vector_get(work, i); in quadratic_preduction() local
103 pred_reduction -= 2.0 * (fi / normf) * betai; in quadratic_preduction()
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/OPTPP/tests/minpack2/
H A Ddmsafg.C31 double betai, v; in dmsafg() local
125 betai = (double) i * hx; in dmsafg()
127 xline = betai * right(j + 1) + (1. - betai) * left(j + 1); in dmsafg()
/dports/science/cantera/cantera-2.5.1-611-gc4d6ecc15/src/thermo/
H A DWaterPropsIAPWSphi.cpp300 static const doublereal betai[3] = { variable
426 exp(-alphai[j]*dtmp*dtmp - betai[j]*ttmp*ttmp)); in phiR()
481 exp(-alphai[j]*dtmp*dtmp - betai[j]*ttmp*ttmp)); in phiR_d()
566 exp(-alphai[j]*dtmp*dtmp - betai[j]*ttmp*ttmp)); in phiR_dd()
686 exp(-alphai[j]*dtmp*dtmp - betai[j]*ttmp*ttmp)); in phiR_t()
687 val += tmp *(tiR[i]/tau - 2.0 * betai[j]*ttmp); in phiR_t()
757 exp(-alphai[j]*dtmp*dtmp - betai[j]*ttmp*ttmp)); in phiR_tt()
758 atmp = tiR[i]/tau - 2.0 * betai[j]*ttmp; in phiR_tt()
759 val += tmp *(atmp * atmp - tiR[i]/(tau*tau) - 2.0*betai[j]); in phiR_tt()
830 exp(-alphai[j]*dtmp*dtmp - betai[j]*ttmp*ttmp)); in phiR_dt()
[all …]
/dports/science/octopus/octopus-10.5/src/system/
H A Dv_ks.F901441 subroutine get_rotation_matrix(dens, alpha, betar, betai) argument
1443 FLOAT, intent(out) :: alpha, betar, betai
1455 betai = M_ZERO
1462 betai = M_TWO * dens(4) / sqrt( M_TWO * mm * (mm + abs(mz)))
1466 betai = -betai
1474 subroutine rotate_to_local(mat, alpha, betar, betai, alpha2, beta2, rot_mat) argument
1476 FLOAT, intent(in) :: alpha, betar, betai, alpha2, beta2
1483 cross = (cmplx(betar, betai))**2 * cmplx(mat(3), -mat(4))
1492 subroutine rotate_to_global(mat, alpha, betar, betai, alpha2, beta2, rot_mat) argument
1494 FLOAT, intent(in) :: alpha, betar, betai, alpha2, beta2
[all …]
H A Dxc_slater_inc.F9064 FLOAT :: rr, socc, nn, mm, alpha, betar, betai, alpha2, beta2
289 call get_rotation_matrix(st%rho(ip, :), alpha, betar, betai)
291 beta2 = betar**2 + betai**2
300 call rotate_to_local(global_b, alpha, betar, betai, alpha2, beta2, local_b)
314 call rotate_to_global(local_v, alpha, betar, betai, alpha2, beta2, global_v)
/dports/math/eclib/eclib-20210318/libsrc/
H A Doldforms.cc182 vector<long>::iterator betai; in getoldclasses() local
198 betai=betalist.begin(); in getoldclasses()
205 beta = *betai++; in getoldclasses()
/dports/science/py-scikit-learn/scikit-learn-1.0.2/sklearn/utils/
H A Doptimize.py104 betai = dri1 / dri0
105 psupi = -ri + betai * psupi
/dports/math/R-cran-VGAM/VGAM/R/
H A Dprofilevglm.R136 betai <- B0[i] + sgn * step * del * std.err[Pnames[i], 1] functionVar
137 ooo <- OOO + matrix(X.vlm[, i] * betai, n.lm, M, byrow = TRUE)
157 ri[, pnamesi] <- betai
/dports/biology/migrate/migrate-3.6.11/src/
H A Dspline.c155 MYREAL (*beta) (MYREAL *), MYREAL (*betai) (MYREAL *),
305 MYREAL (*beta) (MYREAL *), MYREAL (*betai) (MYREAL *), in dalg3_()
390 d__1 = (*betai) (&p1), d__2 = (*betai) (&p2); in dalg3_()
393 d__1 = (*betai) (&p1), d__2 = (*betai) (&p2); in dalg3_()
430 d__1 = (*betai) (&p1), d__2 = (*betai) (&p2); in dalg3_()
433 d__1 = (*betai) (&p1), d__2 = (*betai) (&p2); in dalg3_()
576 betai, &daux2[1], daux3, &info[1], errc, diagn); in dbvc_()
580 betai, &a1[1], &a2[1], d, errc, diagn); in dbvc_()
1222 &work[i10], beta, betai, rho, rhoi, d, d2, errc, diagn); in dbvssc_()
3292 MYREAL (*beta) (MYREAL *), MYREAL (*betai) (MYREAL *), in dstinf_()
[all …]
H A Dspline.h45 … MYREAL (*beta) (MYREAL *), MYREAL (*betai) (MYREAL *), MYREAL (*rho) (MYREAL *),
/dports/science/R-cran-bayesm/bayesm/man/
H A DrhierNegbinRw.Rd121 betai = as.vector(Z[i,]\%*\%Delta) + chol(Vbeta)\%*\%rnorm(nvar)
123 simnegbindata[[i]] = list(y=simnegbin(X,betai,alpha), X=X, beta=betai)
/dports/math/blis/blis-0.8.1/kernels/bgq/3/
H A Dbli_gemm_bgq_int_8x8.c303 double betai = bli_zimag( *beta ); in bli_zgemm_bgq_int_4x4() local
311 betav = vec_insert( betai, betav, 1); in bli_zgemm_bgq_int_4x4()
313 betav = vec_insert( betai, betav, 3); in bli_zgemm_bgq_int_4x4()
/dports/math/xldlas/xldlas/
H A Dtests.c23 extern float betai(float a, float b, float x);
201 tprob = betai(0.5 * total_freedom, 0.5, total_freedom/(total_freedom + tstat * tstat)); in do_eqmeantest()
376 reject_significance = betai(numb_pluses + 1, (nrealobs - numb_equal) - numb_pluses + 1, test_prob); in do_signtest()
/dports/biology/py-orange3-single-cell/orange3-single-cell-0.8.2/orangecontrib/single_cell/preprocess/
H A Dscbnorm.py2 from scipy.special import betainc as betai unknown
63 pf = betai(0.5 * df, 0.5, np.array(df / (df + ts), dtype=float))
/dports/biology/mothur/mothur-1.46.1/source/
H A Dlinearalgebra.h60 double betai(const double, const double, const double);
/dports/biology/gcta/gcta_1.26.0_src/
H A DStatFunc.h35 double betai(double a, double b, double x);
/dports/science/gnudatalanguage/gdl-1.0.1/src/pro/
H A Dr_correlate.pro128 function betai, a, b, x, _extra = _extra
134 ; i = betai(a, b, x)
349 tt = betai(df/2.d, 0.5d, df/(df+t^2))
/dports/math/librsb/librsb-1.2.0.10/
H A Drsb_libspblas_tests.c733 rsb_blas_int_t betai=RSB_INVALID_BLAS_INT_IDX_VAL; in rsb_blas_bigger_matrices_tester() local
886 for(betai=0;betai<sizeof(betaa)/sizeof(rsb_blas_int_t);++betai) in rsb_blas_bigger_matrices_tester()
938 rsb__util_set_area_to_converted_integer(beta,typecode,betaa[betai]); in rsb_blas_bigger_matrices_tester()
1492 if(incX==1 && incB==1) if(alphai==0 && betai==0) /* agnostic to these parameters */ in rsb_blas_bigger_matrices_tester()
1648 if(betai > 0 || alphai > 0) in rsb_blas_bigger_matrices_tester()
1698 if(incX==1 && incB==1) if(alphai==0 && betai==0) /* agnostic to these parameters */ in rsb_blas_bigger_matrices_tester()
2051 if(incX==1 && incB==1) if(alphai==0 && betai==0) /* agnostic to these parameters */ in rsb_blas_bigger_matrices_tester()
2101 …har)typecode,RSB_BLAS_MT_STR(stype),incX,incB,dim,tc,alphaa[alphai],betaa[betai],RSB_BLAS_DIAG_CHA… in rsb_blas_bigger_matrices_tester()
/dports/math/fpc-numlib/fpc-3.2.2/packages/numlib/src/
H A Dspe.pas97 function betai(a, b, x: ArbFloat): ArbFloat; in betai() function
1407 function betai(a, b, x: ArbFloat): ArbFloat; in betai() function
1437 Result := betai(a, b, x) - y;
1463 Result := betai(0.5*n, 0.5, n/(n+t*t));
1484 Result := betai(n2*0.5, n1*0.5, n2 / (n2 + n1*F));
/dports/lang/fpc-source/fpc-3.2.2/packages/numlib/src/
H A Dspe.pas97 function betai(a, b, x: ArbFloat): ArbFloat; in betai() function
1407 function betai(a, b, x: ArbFloat): ArbFloat; in betai() function
1437 Result := betai(a, b, x) - y;
1463 Result := betai(0.5*n, 0.5, n/(n+t*t));
1484 Result := betai(n2*0.5, n1*0.5, n2 / (n2 + n1*F));

1234