Home
last modified time | relevance | path

Searched refs:astep (Results 1 – 25 of 178) sorted by relevance

12345678

/dports/graphics/opencv/opencv-4.5.3/modules/core/src/
H A Dmatrix_decomp.cpp18 astep /= sizeof(A[0]); in LUImpl()
26 if( std::abs(A[j*astep + i]) > std::abs(A[k*astep + i]) ) in LUImpl()
35 std::swap(A[i*astep + j], A[k*astep + j]); in LUImpl()
49 A[j*astep + k] += alpha*A[i*astep + k]; in LUImpl()
100 astep /= sizeof(A[0]); in CholImpl()
109 s -= L[i*astep + k]*L[j*astep + k]; in CholImpl()
110 L[i*astep + j] = (_Tp)(s*L[j*astep + j]); in CholImpl()
112 s = A[i*astep + i]; in CholImpl()
126 L[i*astep + i]=1/L[i*astep + i]; in CholImpl()
168 L[i*astep + i]=1/L[i*astep + i]; in CholImpl()
[all …]
H A Dlapack.cpp120 astep /= sizeof(A[0]); in JacobiImpl_()
202 rotate(A[astep*i+k], A[astep*i+l]); in JacobiImpl_()
204 rotate(A[astep*k+i], A[astep*i+l]); in JacobiImpl_()
206 rotate(A[astep*k+i], A[astep*l+i]); in JacobiImpl_()
449 _Tp *Ai = At + i*astep, *Aj = At + j*astep; in JacobiSVDImpl_()
526 std::swap(At[i*astep + k], At[j*astep + k]); in JacobiSVDImpl_()
562 sd += At[i*astep + k]*At[j*astep + k]; in JacobiSVDImpl_()
566 _Tp t = (_Tp)(At[i*astep + k] - sd*At[j*astep + k]); in JacobiSVDImpl_()
593 hal::SVD32f(At, astep, W, NULL, astep, Vt, vstep, m, n, n1); in JacobiSVD()
598 hal::SVD64f(At, astep, W, NULL, astep, Vt, vstep, m, n, n1); in JacobiSVD()
[all …]
/dports/graphics/opencv/opencv-4.5.3/3rdparty/openvx/hal/
H A Dopenvx_hal.hpp9 int ovx_hal_add(const T *a, size_t astep, const T *b, size_t bstep, T *c, size_t cstep, int w, int …
11 int ovx_hal_sub(const T *a, size_t astep, const T *b, size_t bstep, T *c, size_t cstep, int w, int …
14 int ovx_hal_absdiff(const T *a, size_t astep, const T *b, size_t bstep, T *c, size_t cstep, int w, …
17 int ovx_hal_and(const T *a, size_t astep, const T *b, size_t bstep, T *c, size_t cstep, int w, int …
19 int ovx_hal_or(const T *a, size_t astep, const T *b, size_t bstep, T *c, size_t cstep, int w, int h…
21 int ovx_hal_xor(const T *a, size_t astep, const T *b, size_t bstep, T *c, size_t cstep, int w, int …
22 int ovx_hal_not(const uchar *a, size_t astep, uchar *c, size_t cstep, int w, int h);
25 int ovx_hal_mul(const T *a, size_t astep, const T *b, size_t bstep, T *c, size_t cstep, int w, int …
36 int ovx_hal_filter(cvhalFilter2D *filter_context, uchar *a, size_t astep, uchar *b, size_t bstep, i…
50 int ovx_hal_cvtGraytoBGR(const uchar * a, size_t astep, uchar * b, size_t bstep, int w, int h, int …
[all …]
H A Dopenvx_hal.cpp256 refineStep(w, h, VX_DF_IMAGE_U8, astep); in ovx_hal_not()
325 refineStep(aw, ah, VX_DF_IMAGE_U8, astep); in ovx_hal_resize()
378 refineStep(aw, ah, VX_DF_IMAGE_U8, astep); in ovx_hal_warpAffine()
440 refineStep(aw, ah, VX_DF_IMAGE_U8, astep); in ovx_hal_warpPerspective()
596 refineStep(w, h, VX_DF_IMAGE_U8, astep); in ovx_hal_filter()
817 refineStep(w, h, VX_DF_IMAGE_U8, astep); in ovx_hal_morph()
898 refineStep(w, h, VX_DF_IMAGE_U8, astep); in ovx_hal_cvtGraytoBGR()
947 ptrs.push_back((void*)(a + h * astep)); in ovx_hal_cvtTwoPlaneYUVtoBGR()
982 refineStep(w, h, VX_DF_IMAGE_IYUV, astep); in ovx_hal_cvtThreePlaneYUVtoBGR()
993 ptrs.push_back((void*)(a + h * astep)); in ovx_hal_cvtThreePlaneYUVtoBGR()
[all …]
/dports/science/afni/afni-AFNI_21.3.16/src/
H A Dexx.c7 astep = nx ; bstep = nxy ; cstep = 1 ; \
12 astep = nxy ; bstep = 1 ; cstep = nx ; \
17 astep = 1 ; bstep = nx ; cstep = nxy ; \
31 int astep,bstep,cstep , na,nb,nc ; in getplane_byte() local
42 for( aa=0,aoff=0 ; aa < na ; aa++,aoff+=astep ) in getplane_byte()
53 int astep,bstep,cstep , na,nb,nc ; in putplane_byte() local
64 for( aa=0,aoff=0 ; aa < na ; aa++,aoff+=astep ) in putplane_byte()
75 int astep,bstep,cstep , na,nb,nc ; in swaptest() local
H A Dextor.c81 #define LR astep /* lower right */
83 #define UR (astep+bstep) /* upper right */
110 int astep,bstep,cstep , na,nb,nc , nxy=nx*ny ; in extract_assign_directions() local
114 *Astep = astep ; *Bstep = bstep ; *Cstep = cstep ; in extract_assign_directions()
129 int astep,bstep,cstep , na,nb,nc ; in extract_byte_nn() local
174 int astep,bstep,cstep , na,nb,nc ; in extract_byte_lifl() local
233 int astep,bstep,cstep , na,nb,nc ; in extract_byte_liby() local
609 int astep,bstep,cstep , na,nb,nc ; in extract_byte_speedtest() local
662 int astep,bstep,cstep , na,nb,nc ; in getplane_byte() local
684 int astep,bstep,cstep , na,nb,nc ; in putplane_byte() local
[all …]
H A Dthd_shearwarp.c36 #define LR astep /* voxel offset to lower right */
38 #define UR (astep+bstep) /* voxel offset to upper right */
44 astep = nx ; bstep = nxy ; cstep = 1 ; \
49 astep = nxy ; bstep = 1 ; cstep = nx ; \
54 astep = 1 ; bstep = nx ; cstep = nxy ; \
65 int astep,bstep,cstep , na,nb,nc , nxy=nx*ny ; in extract_assign_directions() local
69 *Astep = astep ; *Bstep = bstep ; *Cstep = cstep ; in extract_assign_directions()
84 int astep,bstep,cstep , na,nb,nc ; in extract_byte_nn() local
104 ijkoff = fixijk*cstep + (abot-adel)*astep + (bbot-bdel)*bstep ; in extract_byte_nn()
112 for( aa=abot,aoff=0 ; aa < atop ; aa++,aoff+=astep ) in extract_byte_nn()
[all …]
H A Dcox_render.c821 int astep,bstep,cstep , na,nb,nc , nxy=nx*ny ; in extract_assign_directions() local
825 *Astep = astep ; *Bstep = bstep ; *Cstep = cstep ; in extract_assign_directions()
840 int astep,bstep,cstep , na,nb,nc ; in extract_byte_nn() local
868 if( astep != 1 ){ in extract_byte_nn()
871 for( aa=abot,aoff=0 ; aa < atop ; aa++,aoff+=astep ) in extract_byte_nn()
896 int astep,bstep,cstep , na,nb,nc ; in extract_rgba_nn() local
924 for( aa=abot,aoff=0 ; aa < atop ; aa++,aoff+=astep ) in extract_rgba_nn()
957 int astep,bstep,cstep , na,nb,nc , nts,dts1=0,dts2=0 ;
1189 int astep,bstep,cstep , na,nb,nc , nn ; in extract_byte_lix() local
1279 int astep,bstep,cstep , na,nb,nc , nn ; in extract_byte_lixx() local
[all …]
/dports/audio/zita-njbridge/zita-njbridge-0.4.8/source/
H A Dnetdata.cc137 void Netdata::put_audio (int chan, int offs, int nsamp, const float *adata, int astep)
150 v = (int)(R16 * adata [i * astep] + 0.5f);
163 v = (int)(R24 * adata [i * astep] + 0.5f);
179 f [i * nch] = adata [i * astep];
192 p += 4 * astep;
203 void Netdata::get_audio (int chan, int offs, int nsamp, float *adata, int astep) const
218 adata [i * astep] = (float)((v << 8) + p [1]) / R16;
229 adata [i * astep] = (float)((v << 16) + (p [1] << 8) + p [2]) / R24;
240 adata [i * astep] = f [i * nch];
254 q += 4 * astep;
/dports/science/qmcpack/qmcpack-3.11.0/src/Numerics/
H A DOneDimGridFactory.cpp28 RealType astep = 1.25e-2; in createGrid() local
38 radAttrib.add(astep, "astep"); in createGrid()
40 radAttrib.add(astep, "step"); in createGrid()
61 …LOGMSG("Using log grid with default values: scale = " << ascale << " step = " << astep << " npts =… in createGrid()
63 agrid->set(astep, ascale, npts); in createGrid()
/dports/graphics/netpbm/netpbm-10.91.01/analyzer/
H A Dpamtilt.c31 float astep; /* initial angle increment */ member
62 cmdlineP->astep = 1.0; /* initially check by one-degree increments */ in parseCommandLine()
71 OPTENT3(0, "astep", OPT_FLOAT, &cmdlineP->astep, NULL, 0); in parseCommandLine()
484 float const astep, in getAngle() argument
495 -maxangle, maxangle, astep, verbose, in getAngle()
498 if ((a < -maxangle + astep / 2) || (a > maxangle - astep / 2)) in getAngle()
506 da = astep / 10; in getAngle()
544 cmdline.maxangle, cmdline.astep, cmdline.qmin, in main()
/dports/math/vtk6/VTK-6.2.0/IO/Geometry/
H A DvtkPlot3DMetaReader.cxx289 const Json::Value& astep = filenames[(int)index]; in SetFileNames() local
292 if (!astep.isMember("time")) in SetFileNames()
299 aTime.Time = astep["time"].asDouble(); in SetFileNames()
302 if (!astep.isMember("xyz")) in SetFileNames()
309 std::string xyzfile = astep["xyz"].asString(); in SetFileNames()
314 if (astep.isMember("q")) in SetFileNames()
316 std::string qfile = astep["q"].asString(); in SetFileNames()
321 if (astep.isMember("function")) in SetFileNames()
323 std::string functionfile = astep["function"].asString(); in SetFileNames()
/dports/math/sisl/SISL-SISL-4.6.0-44-g9114631/src/
H A Ds9adstep.c57 double etang[],double eptan1[],double eptan2[],double astep,int *jstat) in s9adstep() argument
60 eptan1,eptan2,astep,jstat) in s9adstep()
72 double astep;
156 if (DZERO < tdist && tdist <= (double)2.0*astep)
H A Ds9adsimp.c56 double epgd1[],double etang[],double eptan[],double astep,int *jstat) in s9adsimp() argument
58 double s9adsimp(epnt1,epar1,eimpli,ideg,egd1,epgd1,etang,eptan,astep,jstat) in s9adsimp()
67 double astep;
172 if (DZERO < tdist && tdist <= (double)2.0*astep)
H A Ds9iterate.c54 double epar2[],SISLSurf *psurf1,SISLSurf *psurf2,double astep, in s9iterate() argument
58 void s9iterate(epoint,epnt1,epnt2,epar1,epar2,psurf1,psurf2,astep,aepsge, in s9iterate()
67 double astep;
161 spoint[ki] = epoint[ki] + astep*epoint[ki+3];
/dports/math/vtk8/VTK-8.2.0/IO/Parallel/
H A DvtkPlot3DMetaReader.cxx291 const Json::Value& astep = filenames[(int)index]; in SetFileNames() local
294 if (!astep.isMember("time")) in SetFileNames()
301 aTime.Time = astep["time"].asDouble(); in SetFileNames()
304 if (!astep.isMember("xyz")) in SetFileNames()
311 std::string xyzfile = astep["xyz"].asString(); in SetFileNames()
316 if (astep.isMember("q")) in SetFileNames()
318 std::string qfile = astep["q"].asString(); in SetFileNames()
323 if (astep.isMember("function")) in SetFileNames()
325 std::string functionfile = astep["function"].asString(); in SetFileNames()
/dports/math/vtk9/VTK-9.1.0/IO/Parallel/
H A DvtkPlot3DMetaReader.cxx278 const Json::Value& astep = filenames[(int)index]; in SetFileNames() local
281 if (!astep.isMember("time")) in SetFileNames()
288 aTime.Time = astep["time"].asDouble(); in SetFileNames()
291 if (!astep.isMember("xyz")) in SetFileNames()
298 std::string xyzfile = astep["xyz"].asString(); in SetFileNames()
302 if (astep.isMember("q")) in SetFileNames()
304 std::string qfile = astep["q"].asString(); in SetFileNames()
308 if (astep.isMember("function")) in SetFileNames()
310 std::string functionfile = astep["function"].asString(); in SetFileNames()
/dports/graphics/opencv/opencv-4.5.3/contrib/modules/tracking/src/
H A Dprecomp.hpp93 inline choleskyDecomposition( const _Tp* A, size_t astep, int asize, _Tp* L, size_t lstep ) in choleskyDecomposition() argument
97 astep /= sizeof(_Tp); in choleskyDecomposition()
102 L[i*lstep + j] = A[i*astep + j]; in choleskyDecomposition()
/dports/science/qmcpack/qmcpack-3.11.0/src/QMCHamiltonians/
H A DECPComponentBuilder.1.cpp221 mRealType astep = -1.0; in createGrid() local
236 radAttrib.add(astep, "astep"); in createGrid()
238 radAttrib.add(astep, "step"); in createGrid()
256 … app_log() << " Log grid scale=" << ascale << " step=" << astep << " npts=" << npts << std::endl; in createGrid()
258 agrid->set(astep, ascale, npts); in createGrid()
273 if (astep > 0.0) in createGrid()
275 npts = static_cast<int>((rf - ri) / astep) + 1; in createGrid()
/dports/games/bzflag-server/bzflag-2.4.22/src/geometry/
H A DAnimatedTreads.cxx162 const float astep = (float)((M_PI * 2.0) / divs); in buildTread() local
187 const float ang = (float)((astep * (double)i) - (M_PI / 2.0)); in buildTread()
210 const float ang = (float)((astep * (double)i) + (M_PI / 2.0)); in buildTread()
239 const float ang = (float)((astep * (double)i) - (M_PI / 2.0)); in buildTread()
262 const float ang = (float)((astep * (double)i) + (M_PI / 2.0)); in buildTread()
294 const float ang = (float)((astep * (double)i) - (M_PI / 2.0)); in buildTread()
318 const float ang = (float)((astep * (double)i) + (M_PI / 2.0)); in buildTread()
408 const float astep = (float)((M_PI * 2.0) / (double)divs); in buildWheel() local
420 const float ang = astep * (float)i; in buildWheel()
447 const float ang = astep * (float)i; in buildWheel()
[all …]
/dports/games/bzflag/bzflag-2.4.22/src/geometry/
H A DAnimatedTreads.cxx162 const float astep = (float)((M_PI * 2.0) / divs); in buildTread() local
187 const float ang = (float)((astep * (double)i) - (M_PI / 2.0)); in buildTread()
210 const float ang = (float)((astep * (double)i) + (M_PI / 2.0)); in buildTread()
239 const float ang = (float)((astep * (double)i) - (M_PI / 2.0)); in buildTread()
262 const float ang = (float)((astep * (double)i) + (M_PI / 2.0)); in buildTread()
294 const float ang = (float)((astep * (double)i) - (M_PI / 2.0)); in buildTread()
318 const float ang = (float)((astep * (double)i) + (M_PI / 2.0)); in buildTread()
408 const float astep = (float)((M_PI * 2.0) / (double)divs); in buildWheel() local
420 const float ang = astep * (float)i; in buildWheel()
447 const float ang = astep * (float)i; in buildWheel()
[all …]
/dports/math/py-pymc3/pymc-3.11.4/pymc3/step_methods/
H A Darraystep.py160 apoint, stats = self.astep(bij.map(point), *inputs)
163 apoint = self.astep(bij.map(point), *inputs)
196 apoint, stats = self.astep(self.bij.map(point))
199 apoint = self.astep(self.bij.map(point))
276 apoint, stats = self.astep(array)
280 apoint = self.astep(array)
/dports/editors/texmacs/TeXmacs-1.99.4-src/src/Graphics/Types/
H A Dgrid.cpp257 SI astep; // # angles member
259 grid_rep (subd, col, o), step (st), astep (ast) {} in polar_rep()
325 for (j=0; j<astep*nsub; j++) in get_curves()
326 res << create_line (xo, yo, xo+R2*cos((2*tm_PI*j)/(astep*nsub)), in get_curves()
349 a= nearest ((arg(p)/(2*tm_PI))*astep*ssubd); in find_closest_point()
351 a= a/(astep*ssubd); in find_closest_point()
371 return tm_new<polar_rep> (subd, col, o, step, astep); in polar()
517 SI astep= 8; in as_grid() local
525 astep= as_int (t[2]); in as_grid()
531 astep= as_int (t[3]); in as_grid()
[all …]
/dports/graphics/opencv/opencv-4.5.3/modules/core/include/opencv2/core/hal/
H A Dhal.hpp63 CV_EXPORTS int LU32f(float* A, size_t astep, int m, float* b, size_t bstep, int n);
64 CV_EXPORTS int LU64f(double* A, size_t astep, int m, double* b, size_t bstep, int n);
65 CV_EXPORTS bool Cholesky32f(float* A, size_t astep, int m, float* b, size_t bstep, int n);
66 CV_EXPORTS bool Cholesky64f(double* A, size_t astep, int m, double* b, size_t bstep, int n);
67 CV_EXPORTS void SVD32f(float* At, size_t astep, float* W, float* U, size_t ustep, float* Vt, size_t…
69 CV_EXPORTS int QR32f(float* A, size_t astep, int m, int n, int k, float* b, size_t bstep, float* hF…
70 CV_EXPORTS int QR64f(double* A, size_t astep, int m, int n, int k, double* b, size_t bstep, double*…
234 CV_EXPORTS int LU(float* A, size_t astep, int m, float* b, size_t bstep, int n);
235 CV_EXPORTS int LU(double* A, size_t astep, int m, double* b, size_t bstep, int n);
236 CV_EXPORTS bool Cholesky(float* A, size_t astep, int m, float* b, size_t bstep, int n);
[all …]
/dports/net-mgmt/librenms/librenms-vendor-21.5.1/amenadiel/jpgraph/src/plot/
H A DRadarPlot.php93 $astep = 2 * M_PI / $nbrpnts;
118 $a += $astep;
122 $a += $astep;

12345678