Home
last modified time | relevance | path

Searched refs:offdiag (Results 1 – 25 of 481) sorted by relevance

12345678910>>...20

/dports/math/R-cran-bdsmatrix/bdsmatrix/R/
H A Dbdsmatrix.R6 offdiag = 'numeric', repr in bdsmatrix
11 x@offdiag <- callGeneric(x@offdiag)
18 x@offdiag <- callGeneric(x@offdiag, digits)
37 max(c(x@offdiag, x@blocks), na.rm=na.rm)
45 min(c(x@offdiag, x@blocks), na.rm=na.rm)
118 if (x@offdiag==0) return(x@offdiag)
119 if (!is.na(x@offdiag) || na.rm==FALSE) tprod<- x@offdiag^nz
142 e1@offdiag <- callGeneric(e1@offdiag, e2)
160 e2@offdiag <- callGeneric(e1, e2@offdiag)
180 e1@offdiag <- callGeneric(e1@offdiag, e2@offdiag)
[all …]
/dports/audio/praat/praat-6.2.03/external/gsl/
H A Dgsl_linalg__tridiag.c40 const double offdiag[], size_t o_stride, in solve_tridiag() argument
65 gamma[0] = offdiag[0] / alpha[0]; in solve_tridiag()
211 const double offdiag[], size_t o_stride, in solve_cyc_tridiag() argument
241 gamma[0] = offdiag[0] / alpha[0]; in solve_cyc_tridiag()
265 …gamma[N - 2] = (offdiag[o_stride * (N - 2)] - offdiag[o_stride * (N - 3)] * delta[N - 3]) / alpha[… in solve_cyc_tridiag()
447 const gsl_vector * offdiag, in gsl_linalg_solve_symm_tridiag() argument
455 else if (offdiag->size != rhs->size-1) in gsl_linalg_solve_symm_tridiag()
466 offdiag->data, offdiag->stride, in gsl_linalg_solve_symm_tridiag()
513 const gsl_vector * offdiag, in gsl_linalg_solve_symm_cyc_tridiag() argument
521 else if (offdiag->size != rhs->size) in gsl_linalg_solve_symm_cyc_tridiag()
[all …]
/dports/math/gsl/gsl-2.7/linalg/
H A Dtridiag.c40 const double offdiag[], size_t o_stride, in solve_tridiag() argument
65 gamma[0] = offdiag[0] / alpha[0]; in solve_tridiag()
211 const double offdiag[], size_t o_stride, in solve_cyc_tridiag() argument
246 gamma[0] = offdiag[0] / alpha[0]; in solve_cyc_tridiag()
270 …gamma[N - 2] = (offdiag[o_stride * (N - 2)] - offdiag[o_stride * (N - 3)] * delta[N - 3]) / alpha[… in solve_cyc_tridiag()
452 const gsl_vector * offdiag, in gsl_linalg_solve_symm_tridiag() argument
460 else if (offdiag->size != rhs->size-1) in gsl_linalg_solve_symm_tridiag()
471 offdiag->data, offdiag->stride, in gsl_linalg_solve_symm_tridiag()
518 const gsl_vector * offdiag, in gsl_linalg_solve_symm_cyc_tridiag() argument
526 else if (offdiag->size != rhs->size) in gsl_linalg_solve_symm_cyc_tridiag()
[all …]
/dports/science/py-scipy/scipy-1.7.1/scipy/optimize/_trlib/
H A Dtrlib_tri_factor.c31 trlib_int_t nirblk, trlib_int_t *irblk, trlib_flt_t *diag, trlib_flt_t *offdiag, in trlib_tri_factor_min() argument
310 *sub_fail = trlib_eigen_inverse(n0, diag, offdiag, in trlib_tri_factor_min()
346 …TRLIB_DLAGTM("N", &n0, &inc, &ferr, offdiag, diag, offdiag, sol, &n0, &ferr, w, &n0) // w <-- T*so… in trlib_tri_factor_min()
367 …TRLIB_DLAGTM("N", &n0, &inc, &ferr, offdiag, diag, offdiag, sol, &n0, &ferr, w, &n0) // w <-- T*so… in trlib_tri_factor_min()
415 …TRLIB_DLAGTM("N", &n0, &inc, &ferr, offdiag, diag, offdiag, sol, &n0, &ferr, w, &n0) // w <-- T*so… in trlib_tri_factor_min()
422 trlib_int_t n, trlib_flt_t *diag, trlib_flt_t *offdiag, in trlib_tri_factor_regularized_umin() argument
465 trlib_int_t n, trlib_flt_t *diag, trlib_flt_t *offdiag, in trlib_tri_factor_get_regularization() argument
595 trlib_int_t n, trlib_flt_t *diag, trlib_flt_t *offdiag, in trlib_tri_factor_regularize_posdef() argument
613 if ( diag[pivot+1] - offdiag[pivot]*offdiag[pivot]/diag_fac <= tol_away * diag_fac ) { in trlib_tri_factor_regularize_posdef()
614 … regdiag[pivot+1] = security_step * fabs(offdiag[pivot]*offdiag[pivot]/diag_fac - diag[pivot+1]); in trlib_tri_factor_regularize_posdef()
[all …]
H A Dtrlib_leftmost.c31 trlib_int_t nirblk, trlib_int_t *irblk, trlib_flt_t *diag, trlib_flt_t *offdiag, in trlib_leftmost() argument
41 …curret = trlib_leftmost_irreducible(irblk[ii+1]-irblk[ii], diag+irblk[ii], offdiag+irblk[ii], 0, 0… in trlib_leftmost()
51 …eftmost_irreducible(irblk[nirblk] - irblk[nirblk-1], diag+irblk[nirblk-1], offdiag+irblk[nirblk-1], in trlib_leftmost()
59 trlib_int_t n, trlib_flt_t *diag, trlib_flt_t *offdiag, in trlib_leftmost_irreducible() argument
100 oabs0 = fabs(offdiag[0]); oabs1 = fabs(offdiag[n-2]); in trlib_leftmost_irreducible()
104 oabs1 = fabs(offdiag[ii]); in trlib_leftmost_irreducible()
178 obyprlp = offdiag[jj-1]/prlp; in trlib_leftmost_irreducible()
182 dprlp = -1.0 + offdiag[jj-1]*offdiag[jj-1]*dprlp / (prlp*prlp); in trlib_leftmost_irreducible()
183 prlp = diag[jj] - *leftmost - offdiag[jj-1]*obyprlp; in trlib_leftmost_irreducible()
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/C3/src/lib_quadrature/
H A Dquadrature.c227 double * offdiag = calloc_double(N); in gauss_hermite() local
233 offdiag[ii] = sqrt((double)(ii+1)); in gauss_hermite()
237 dstev_("V", &M, pts, offdiag, evec, &M2, work, &info); in gauss_hermite()
251 free(offdiag); offdiag = NULL; in gauss_hermite()
288 double * offdiag = calloc_double(N); in gauss_legendre() local
296 offdiag[ii] = temp / sqrt( (2.0 * temp + 1.0) * (2.0 * temp -1.0) ); in gauss_legendre()
303 dstev_("V", &M, pts, offdiag, evec, &M2, work, &info); in gauss_legendre()
320 free(offdiag); offdiag = NULL; in gauss_legendre()
/dports/graphics/hugin/hugin-2020.0.0/src/hugin_base/hugin_math/
H A Deig_jacobi.cpp90 double pp, qq, pq, offdiag; in eig_jacobi() local
100 offdiag = 0.0; in eig_jacobi()
103 offdiag = offdiag + a[k][l] * a[k][l]; in eig_jacobi()
107 mu1 = sqrt( offdiag ) / n ; in eig_jacobi()
179 offdiag = 0.0; in eig_jacobi()
182 offdiag = offdiag + a[k][l] * a[k][l]; in eig_jacobi()
185 mu3 = sqrt( offdiag ) / n; in eig_jacobi()
201 *epsilon = offdiag; in eig_jacobi()
/dports/science/py-ase/ase-3.22.0/ase/io/
H A Dlammpsrun.py217 def construct_cell(diagdisp, offdiag): argument
227 xy, xz, yz = offdiag
292 offdiag = celldata[:, 2]
298 offdiag = offdiag[sort_index]
300 offdiag = (0.0,) * 3
302 cell, celldisp = construct_cell(diagdisp, offdiag)
412 offdiag = read_variables("=3d")
414 offdiag = (0.0,) * 3
450 cell, celldisp = construct_cell(diagdisp, offdiag)
/dports/math/R-cran-lava/lava/man/
H A Drevdiag.Rd6 \alias{offdiag}
7 \alias{offdiag<-}
11 offdiag(x,type=0,...)
14 offdiag(x,type=0,...) <- value
/dports/math/R-cran-bdsmatrix/bdsmatrix/src/
H A Dbdsmatrix_prod.c20 double *bmat, double *rmat, double *offdiag, in bdsmatrix_prod() argument
45 if (*offdiag != 0) { in bdsmatrix_prod()
51 bmat[n++] -= *offdiag; in bdsmatrix_prod()
62 if (*offdiag !=0) { in bdsmatrix_prod()
65 offsum *= *offdiag; in bdsmatrix_prod()
/dports/science/qbox/qbox-public-rel1_73_3/src/
H A DD3tensor.h78 explicit D3tensor(const D3vector& diag, const D3vector& offdiag) in D3tensor() argument
83 a_[1] = offdiag[0]; in D3tensor()
84 a_[5] = offdiag[1]; in D3tensor()
85 a_[2] = offdiag[2]; in D3tensor()
86 a_[3] = offdiag[0]; in D3tensor()
87 a_[7] = offdiag[1]; in D3tensor()
88 a_[6] = offdiag[2]; in D3tensor()
/dports/math/suitesparse-config/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-klu/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-amd/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-mongoose/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-rbio/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-ldl/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-colamd/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-cholmod/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-ccolamd/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-spqr/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-slip_lu/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-camd/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-btf/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;
/dports/math/suitesparse-umfpack/SuiteSparse-5.10.1/GraphBLAS/GraphBLAS/test/
H A Dgbtest61.m23 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L1))) ;
35 assert (isequal (GrB.offdiag (L0), GrB.offdiag (L2))) ;

12345678910>>...20