Home
last modified time | relevance | path

Searched refs:icols (Results 1 – 25 of 281) sorted by relevance

12345678910>>...12

/dports/math/qposases/qpOASES-3.2.1/src/
H A DMatrices.cpp873 j = icols->number[icols->iSort[k]]; in getRow()
880 j = icols->number[icols->iSort[k]]; in getRow()
887 j = icols->number[icols->iSort[k]]; in getRow()
1580 if (ic[j] == icols->number[icols->iSort[i]]) in getRow()
1588 if (ic[j] == icols->number[icols->iSort[i]]) in getRow()
1596 if (ic[j] == icols->number[icols->iSort[i]]) in getRow()
1991 if (ic[j] == icols->number[icols->iSort[i]]) in transTimes()
2008 if (ic[j] == icols->number[icols->iSort[i]]) in transTimes()
2025 if (ic[j] == icols->number[icols->iSort[i]]) in transTimes()
2161 col = icols->number[icols->iSort[l]]; in bilinear()
[all …]
/dports/math/casadi/casadi-3.5.5/external_packages/qpOASES/src/
H A DMatrices.cpp818 j = icols->number[icols->iSort[k]]; in getRow()
825 j = icols->number[icols->iSort[k]]; in getRow()
832 j = icols->number[icols->iSort[k]]; in getRow()
1510 if (ic[j] == icols->number[icols->iSort[i]]) in getRow()
1518 if (ic[j] == icols->number[icols->iSort[i]]) in getRow()
1526 if (ic[j] == icols->number[icols->iSort[i]]) in getRow()
1921 if (ic[j] == icols->number[icols->iSort[i]]) in transTimes()
1938 if (ic[j] == icols->number[icols->iSort[i]]) in transTimes()
1955 if (ic[j] == icols->number[icols->iSort[i]]) in transTimes()
2091 col = icols->number[icols->iSort[l]]; in bilinear()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/mat/impls/aij/seq/bas/
H A Dspbas.c115 result->icols[i] = result->icols[i-1] + result->row_nnz[i-1]; in spbas_allocate_data()
261 PetscInt *icols; in spbas_compress_pattern() local
325 B->icols[i][j] = icols[j]; in spbas_compress_pattern()
329 B->icols[i][j] = icols[j]-i; in spbas_compress_pattern()
333 B->icols[i][j] = icols[j]-icols[0]; in spbas_compress_pattern()
342 B->icols[i] = B->icols[ipoint[i]]; in spbas_compress_pattern()
662 icols[i] = matrix_A->icols[ip]; in spbas_apply_reordering_rows()
672 matrix_A->icols = icols; in spbas_apply_reordering_rows()
696 icols = matrix_A->icols[i]; in spbas_apply_reordering_cols()
701 icols[j] = permutation[i+icols[j]]-i; in spbas_apply_reordering_cols()
[all …]
H A Dspbas_cholesky.h11 retval.icols[k] = &retval.alloc_icol[*n_alloc_used]; in spbas_cholesky_row_alloc()
126 i_here = result->icols[i]-result->alloc_icol; in spbas_cholesky_garbage_collect()
152 i_here = result->icols[i]-result->alloc_icol; in spbas_cholesky_garbage_collect()
182 result->icols[i] = result->alloc_icol + (result->icols[i] - alloc_icol_old); in spbas_cholesky_garbage_collect()
215 i_here = result->icols[i]-result->alloc_icol; in spbas_cholesky_garbage_collect()
321 p_icol = pattern.icols[i]; in spbas_incomplete_cholesky()
330 p_icol = pattern.icols[i]; in spbas_incomplete_cholesky()
333 r_icol = retval.icols[i]; in spbas_incomplete_cholesky()
374 r_icol = retval.icols[i]; in spbas_incomplete_cholesky()
390 r1_icol = retval.icols[k]; in spbas_incomplete_cholesky()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/mat/impls/aij/seq/crl/
H A Dcrl.c21 ierr = PetscFree2(aijcrl->acols,aijcrl->icols);CHKERRQ(ierr); in MatDestroy_SeqAIJCRL()
42 PetscInt i, j,rmax = a->rmax,*icols, *ilen = a->ilen; in MatSeqAIJCRL_create_aijcrl() local
52 ierr = PetscFree2(aijcrl->acols,aijcrl->icols);CHKERRQ(ierr); in MatSeqAIJCRL_create_aijcrl()
53 ierr = PetscMalloc2(rmax*m,&aijcrl->acols,rmax*m,&aijcrl->icols);CHKERRQ(ierr); in MatSeqAIJCRL_create_aijcrl()
55 icols = aijcrl->icols; in MatSeqAIJCRL_create_aijcrl()
59 icols[j*m+i] = *aj++; in MatSeqAIJCRL_create_aijcrl()
63 icols[j*m+i] = (j) ? icols[(j-1)*m+i] : 0; /* handle case where row is EMPTY */ in MatSeqAIJCRL_create_aijcrl()
97 PetscInt rmax = aijcrl->rmax,*icols = aijcrl->icols; in MatMult_AIJCRL() local
123 fortranmultcrl_(&m,&rmax,x,y,icols,acols); in MatMult_AIJCRL()
127 for (j=0; j<m; j++) y[j] = acols[j]*x[icols[j]]; in MatMult_AIJCRL()
[all …]
/dports/multimedia/librespot/librespot-0.1.3/cargo-crates/nalgebra-0.18.1/tests/sparse/
H A Dcs_conversion.rs23 let mut icols = vec![0, 1, 3, 4, 0, 1, 2, 3, 2, 1, 2, 4]; in cs_matrix_from_triplet() localVariable
45 let cs_mat = CsMatrix::from_triplet(4, 5, &irows, &icols, &vals); in cs_matrix_from_triplet()
60 icols.swap(*i, *j); in cs_matrix_from_triplet()
64 let cs_mat = CsMatrix::from_triplet(4, 5, &irows, &icols, &vals); in cs_matrix_from_triplet()
76 let mut ic = icols.clone(); in cs_matrix_from_triplet()
79 icols.append(&mut ic); in cs_matrix_from_triplet()
82 let cs_mat = CsMatrix::from_triplet(4, 5, &irows, &icols, &vals); in cs_matrix_from_triplet()
/dports/graphics/librsvg2-rust/librsvg-2.52.8/vendor/nalgebra/tests/sparse/
H A Dcs_conversion.rs23 let mut icols = vec![0, 1, 3, 4, 0, 1, 2, 3, 2, 1, 2, 4]; in cs_matrix_from_triplet() localVariable
45 let cs_mat = CsMatrix::from_triplet(4, 5, &irows, &icols, &vals); in cs_matrix_from_triplet()
59 icols.swap(*i, *j); in cs_matrix_from_triplet()
63 let cs_mat = CsMatrix::from_triplet(4, 5, &irows, &icols, &vals); in cs_matrix_from_triplet()
74 let mut ic = icols.clone(); in cs_matrix_from_triplet()
77 icols.append(&mut ic); in cs_matrix_from_triplet()
80 let cs_mat = CsMatrix::from_triplet(4, 5, &irows, &icols, &vals); in cs_matrix_from_triplet()
/dports/audio/spotifyd/spotifyd-0.3.0/cargo-crates/nalgebra-0.18.1/tests/sparse/
H A Dcs_conversion.rs23 let mut icols = vec![0, 1, 3, 4, 0, 1, 2, 3, 2, 1, 2, 4]; in cs_matrix_from_triplet() localVariable
45 let cs_mat = CsMatrix::from_triplet(4, 5, &irows, &icols, &vals); in cs_matrix_from_triplet()
60 icols.swap(*i, *j); in cs_matrix_from_triplet()
64 let cs_mat = CsMatrix::from_triplet(4, 5, &irows, &icols, &vals); in cs_matrix_from_triplet()
76 let mut ic = icols.clone(); in cs_matrix_from_triplet()
79 icols.append(&mut ic); in cs_matrix_from_triplet()
82 let cs_mat = CsMatrix::from_triplet(4, 5, &irows, &icols, &vals); in cs_matrix_from_triplet()
/dports/multimedia/opentoonz/opentoonz-1.5.0/thirdparty/superlu/SuperLU_4.1/TESTING/MATGEN/
H A Dclatme.c47 static integer icols, idist; in clatme_() local
520 icols = *n + *kl - jcr; in clatme_()
550 i__2 = icols + 1; in clatme_()
564 icols = *n + 1 - jcr; in clatme_()
568 clarfg_(&icols, &xnorms, &work[2], &c__1, &tau); in clatme_()
572 i__2 = icols - 1; in clatme_()
578 &work[1], &c__1, &c_b1, &work[icols + 1], &c__1); in clatme_()
580 cgerc_(&irows, &icols, &q__1, &work[icols + 1], &c__1, &work[1], & in clatme_()
584 c__1, &c_b1, &work[icols + 1], &c__1); in clatme_()
587 cgerc_(&icols, n, &q__1, &work[1], &c__1, &work[icols + 1], &c__1, in clatme_()
[all …]
H A Dzlatme.c41 static integer icols; in zlatme_() local
524 icols = *n + *kl - jcr; in zlatme_()
554 i__2 = icols + 1; in zlatme_()
568 icols = *n + 1 - jcr; in zlatme_()
572 zlarfg_(&icols, &xnorms, &work[2], &c__1, &tau); in zlatme_()
576 i__2 = icols - 1; in zlatme_()
582 &work[1], &c__1, &c_b1, &work[icols + 1], &c__1); in zlatme_()
584 zgerc_(&irows, &icols, &z__1, &work[icols + 1], &c__1, &work[1], & in zlatme_()
588 c__1, &c_b1, &work[icols + 1], &c__1); in zlatme_()
591 zgerc_(&icols, n, &z__1, &work[1], &c__1, &work[icols + 1], &c__1, in zlatme_()
[all …]
H A Dslatme.c38 static integer icols; in slatme_() local
595 icols = *n + *kl - jcr; in slatme_()
629 icols = *n + 1 - jcr; in slatme_()
631 scopy_(&icols, &a[ir + jcr * a_dim1], lda, &work[1], &c__1); in slatme_()
633 slarfg_(&icols, &xnorms, &work[2], &c__1, &tau); in slatme_()
636 sgemv_("N", &irows, &icols, &c_b39, &a[ir + 1 + jcr * a_dim1], in slatme_()
637 lda, &work[1], &c__1, &c_b23, &work[icols + 1], &c__1) in slatme_()
640 sger_(&irows, &icols, &r__1, &work[icols + 1], &c__1, &work[1], & in slatme_()
644 c__1, &c_b23, &work[icols + 1], &c__1); in slatme_()
646 sger_(&icols, n, &r__1, &work[1], &c__1, &work[icols + 1], &c__1, in slatme_()
[all …]
H A Ddlatme.c44 static integer icols; in dlatme_() local
601 icols = *n + *kl - jcr; in dlatme_()
635 icols = *n + 1 - jcr; in dlatme_()
637 dcopy_(&icols, &a[ir + jcr * a_dim1], lda, &work[1], &c__1); in dlatme_()
639 dlarfg_(&icols, &xnorms, &work[2], &c__1, &tau); in dlatme_()
642 dgemv_("N", &irows, &icols, &c_b39, &a[ir + 1 + jcr * a_dim1], in dlatme_()
643 lda, &work[1], &c__1, &c_b23, &work[icols + 1], &c__1) in dlatme_()
646 dger_(&irows, &icols, &d__1, &work[icols + 1], &c__1, &work[1], & in dlatme_()
650 c__1, &c_b23, &work[icols + 1], &c__1); in dlatme_()
652 dger_(&icols, n, &d__1, &work[1], &c__1, &work[icols + 1], &c__1, in dlatme_()
[all …]
/dports/math/superlu/superlu-5.2.2/TESTING/MATGEN/
H A Dclatme.c46 static integer icols, idist; in clatme_slu() local
520 icols = *n + *kl - jcr; in clatme_slu()
550 i__2 = icols + 1; in clatme_slu()
564 icols = *n + 1 - jcr; in clatme_slu()
568 clarfg_(&icols, &xnorms, &work[2], &c__1, &tau); in clatme_slu()
572 i__2 = icols - 1; in clatme_slu()
578 &work[1], &c__1, &c_b1, &work[icols + 1], &c__1); in clatme_slu()
580 cgerc_(&irows, &icols, &q__1, &work[icols + 1], &c__1, &work[1], & in clatme_slu()
584 c__1, &c_b1, &work[icols + 1], &c__1); in clatme_slu()
587 cgerc_(&icols, n, &q__1, &work[1], &c__1, &work[icols + 1], &c__1, in clatme_slu()
[all …]
/dports/math/qposases/qpOASES-3.2.1/include/qpOASES/
H A DMatrices.hpp107 const Indexlist* const icols, /**< Index list specifying columns. */
127 const Indexlist* const icols, /**< Index list specifying columns. */
162 const Indexlist* const icols, /**< Index list specifying columns. */
216 const Indexlist* const icols, /**< Index list specifying columns. */
230 const Indexlist* const icols, /**< Index list specifying columns. */
386 const Indexlist* const icols, /**< Index list specifying columns. */
445 const Indexlist* const icols, /**< Index list specifying columns. */
459 const Indexlist* const icols, /**< Index list specifying columns. */
628 const Indexlist* const icols, /**< Index list specifying columns. */
681 const Indexlist* const icols, /**< Index list specifying columns. */
[all …]
/dports/math/casadi/casadi-3.5.5/external_packages/qpOASES/include/qpOASES/
H A DMatrices.hpp155 … const Indexlist* const icols, /**< Index list specifying columns. */
175 const Indexlist* const icols, /**< Index list specifying columns. */
210 const Indexlist* const icols, /**< Index list specifying columns. */
264 … const Indexlist* const icols, /**< Index list specifying columns. */
425 … const Indexlist* const icols, /**< Index list specifying columns. */
484 … const Indexlist* const icols, /**< Index list specifying columns. */
498 … const Indexlist* const icols, /**< Index list specifying columns. */
650 … const Indexlist* const icols, /**< Index list specifying columns. */
703 … const Indexlist* const icols, /**< Index list specifying columns. */
827 … const Indexlist* const icols, /**< Index list specifying columns. */
[all …]
/dports/science/PETSc/petsc-3.14.1/src/mat/impls/aij/mpi/crl/
H A Dmcrl.c25 ierr = PetscFree2(aijcrl->acols,aijcrl->icols);CHKERRQ(ierr); in MatDestroy_MPIAIJCRL()
45 PetscInt i, j,rmax = 0,*icols, *ailen = Aij->ilen, *bilen = Bij->ilen; in MatMPIAIJCRL_create_aijcrl() local
58 ierr = PetscFree2(aijcrl->acols,aijcrl->icols);CHKERRQ(ierr); in MatMPIAIJCRL_create_aijcrl()
59 ierr = PetscMalloc2(rmax*m,&aijcrl->acols,rmax*m,&aijcrl->icols);CHKERRQ(ierr); in MatMPIAIJCRL_create_aijcrl()
61 icols = aijcrl->icols; in MatMPIAIJCRL_create_aijcrl()
65 icols[j*m+i] = *aj++; in MatMPIAIJCRL_create_aijcrl()
69 icols[j*m+i] = nd + *bj++; in MatMPIAIJCRL_create_aijcrl()
73 icols[j*m+i] = (j) ? icols[(j-1)*m+i] : 0; /* handle case where row is EMPTY */ in MatMPIAIJCRL_create_aijcrl()
/dports/science/PETSc/petsc-3.14.1/src/mat/impls/aij/seq/crl/ftn-kernels/
H A Dfmultcrl.F907 subroutine FortranMultCRL(m,rmax,x,y,icols,acols) argument
9 PetscInt m,rmax,icols(m,rmax)
16 y(j) = acols(j,1)*x(icols(j,1))
21 y(j) = y(j) + acols(j,i)*x(icols(j,i))
/dports/cad/calculix-ccx/CalculiX/ccx_2.18/src/
H A Dcmatrix.f19 subroutine cmatrix(ad,au,jqs,irows,icols,ndesi,nodedesi, argument
26 integer jqs(*),irows(*),icols(*),ndesi,nodedesi(*), local
41 call nident(irows(jqs(kk)),ipos1,icols(kk),ipos2)
45 call nident(irows(jqs(ipos1)),kk,icols(ipos1),ipos2)
H A Ddmatrix.f19 subroutine dmatrix(ad,au,jqs,irows,icols,ndesi,nodedesi, argument
26 integer jqs(*),irows(*),icols(*),ndesi,nodedesi(*),idof,j,jdof, local
40 call nident(irows(jqs(ipos1)),ipos2,icols(ipos1),ipos3)
/dports/multimedia/librespot/librespot-0.1.3/cargo-crates/nalgebra-0.18.1/src/sparse/
H A Dcs_matrix_conversion.rs16 icols: &[usize], in from_triplet()
20 Self::from_triplet_generic(Dynamic::new(nrows), Dynamic::new(ncols), irows, icols, vals) in from_triplet()
32 icols: &[usize], in from_triplet_generic()
37 assert!(vals.len() == icols.len()); in from_triplet_generic()
43 for j in icols.iter().cloned() { in from_triplet_generic()
53 .zip(icols.iter().cloned()) in from_triplet_generic()
/dports/graphics/librsvg2-rust/librsvg-2.52.8/vendor/nalgebra/src/sparse/
H A Dcs_matrix_conversion.rs16 icols: &[usize], in from_triplet()
19 Self::from_triplet_generic(Dynamic::new(nrows), Dynamic::new(ncols), irows, icols, vals) in from_triplet()
32 icols: &[usize], in from_triplet_generic()
36 assert!(vals.len() == icols.len()); in from_triplet_generic()
42 for j in icols.iter().cloned() { in from_triplet_generic()
52 .zip(icols.iter().cloned()) in from_triplet_generic()
/dports/audio/spotifyd/spotifyd-0.3.0/cargo-crates/nalgebra-0.18.1/src/sparse/
H A Dcs_matrix_conversion.rs16 icols: &[usize],
20 Self::from_triplet_generic(Dynamic::new(nrows), Dynamic::new(ncols), irows, icols, vals)
32 icols: &[usize],
37 assert!(vals.len() == icols.len());
43 for j in icols.iter().cloned() {
53 .zip(icols.iter().cloned())
/dports/science/dynare/dynare-4.6.4/matlab/
H A Devaluate_dynamic_model.m24 icols = find(leadlagincidence'); variable
27 …residuals(:,t-1) = dynamicmodel(endogenousvariables(icols), exogenousvariables, params, steadystat…
28 icols = icols + ny; variable
/dports/biology/vcftools/vcftools-0.1.16/src/perl/
H A Dvcf-isec151 my @icols = @{$$vcfs[$ivcf]{columns}};
154 (@icols>9 ? scalar @icols - 9 : 0), ": ",
155 join(',',@icols[9..$#icols]),"\n",
166 my @icols = @{$$vcfs[$ivcf]{columns}};
169 join(',',@icols[9..$#icols]),"\n",
179 my @icols = @{$$vcfs[$ivcf]{columns}};
182 join(',',@icols[9..$#icols]),"\n",
/dports/devel/R-cran-data.table/data.table/R/
H A Dbmerge.R2 bmerge = function(i, x, icols, xcols, roll, rollends, nomatch, mult, ops, verbose) argument
37 if (nrow(i)) for (a in seq_along(icols)) {
42 ic = icols[a]
49 if (roll!=0.0 && a==length(icols))
120 io = identical(icols, head(chmatch(key(i), names(i)), length(icols)))
181 …ans = .Call(Cbmerge, i, x, as.integer(icols), as.integer(xcols), io, xo, roll, rollends, nomatch, …

12345678910>>...12