Home
last modified time | relevance | path

Searched refs:Ay (Results 1 – 25 of 1719) sorted by relevance

12345678910>>...69

/dports/misc/mnn/MNN-1.2.0/source/backend/cpu/x86_x64/avx512/
H A DGemm24_4_4.hpp187 auto Ay = A; in _AVX512_MNNPackedMatMul_24() local
193 Ay = A + sy * 96; in _AVX512_MNNPackedMatMul_24()
243 auto Ay = A; in _AVX512_MNNPackedMatMul_20_4() local
294 auto Ay = A; in _AVX512_MNNPackedMatMul_16_4() local
339 auto Ay = A; in _AVX512_MNNPackedMatMul_12_4() local
379 auto Ay = A; in _AVX512_MNNPackedMatMul_8_4() local
404 auto Ay = A; in _AVX512_MNNPackedMatMul_5_4() local
476 auto Ay = A; in _AVX512_MNNPackedMatMul_4_4() local
500 auto Ay = A; in _AVX512_MNNPackedMatMul_3_4() local
543 auto Ay = A; in _AVX512_MNNPackedMatMul_2_4() local
[all …]
/dports/editors/ted/Ted-2.23/appUtil/
H A Dgeo2DInteger.c59 numXcd= ( Ay- Cy )* ( Bx- Ax )- ( Ax- Cx )* ( By- Ay ); in geo2DIIntersectSegments()
75 C_AB= ( Cy- Ay )/ ( By- Ay ); in geo2DIIntersectSegments()
76 D_AB= ( Dy- Ay )/ ( By- Ay ); in geo2DIIntersectSegments()
82 D_AB= ( Dy- Ay )/ ( By- Ay ); in geo2DIIntersectSegments()
97 p1->y= Ay; in geo2DIIntersectSegments()
114 p1->y= Ay; in geo2DIIntersectSegments()
139 p1->y= Ay; in geo2DIIntersectSegments()
156 p1->y= Ay; in geo2DIIntersectSegments()
190 p1->y= p2->y= Ay+ xab* ( By- Ay ); in geo2DIIntersectSegments()
221 double L2= ( Bx- Ax )* ( Bx- Ax )+ ( By- Ay )* ( By- Ay ); in geo2DIDistanceToLine()
[all …]
/dports/math/giacxcas/giac-1.6.0/check/
H A Dgeo.out5 parameter([Ay,-10.0,10.0,-1,0]),
6 pnt(pnt[Ax+i*Ay,[536870968],A]),
13 pnt(pnt[group[Ax+i*Ay,Bx+i*By,Cx+i*Cy,Ax+i*Ay],56]),
14 pnt(pnt[line[Ax+i*Ay,(Bx+i*By+Cx+i*Cy)/2],56,a]),
15 pnt(pnt[line[Bx+i*By,(Cx+i*Cy+Ax+i*Ay)/2],56,b]),
16 pnt(pnt[line[Cx+i*Cy,(Ax+i*Ay+Bx+i*By)/2],56,c]),
17 pnt(pnt[1/3*Ax+i/3*Ay+1/3*Bx+i/3*By+1/3*Cx+i/3*Cy,56,M]),
21 pnt(pnt[line[-By+Ay+(Ax+Bx)/2+i*(-Ax+Bx+(Ay+By)/2),By-Ay+(Ax+Bx)/2+i*(Ax-Bx+(Ay+By)/2)],56,a]),
23 pnt(pnt[line[-Ay+Cy+(Cx+Ax)/2+i*(-Cx+Ax+(Cy+Ay)/2),Ay-Cy+(Cx+Ax)/2+i*(Cx-Ax+(Cy+Ay)/2)],56,c]),
24Ay^2*Bx+Ay^2*By+i*Ay^2*Cx-Ay^2*Cy-Ay*Bx^2-Ay*By^2+Ay*Cx^2+Ay*Cy^2+(-i)*Bx^2*Cx+Bx^2*Cy+i*Bx*Cx^2+i…
[all …]
/dports/devel/blitz/blitz-1.0.2/examples/
H A Dcurldiv.cpp9 BZ_DECLARE_STENCIL8(test,Ax,Ay,Az,curlA,divA,gradAx,gradAy,gradAz)
10 curlA = curl(Ax,Ay,Az);
11 divA = div(Ax,Ay,Az);
13 gradAy = grad3D(Ay);
19 Array<float,3> Ax, Ay, Az, divA; in main() local
22 allocateArrays(shape(N,N,N), Ax, Ay, Az, divA); in main()
33 Ay = sin(cx(i)) + sin(cy(j)) + sin(cz(k)); in main()
36 applyStencil(test(), Ax, Ay, Az, curlA, divA, gradAx, gradAy, gradAz); in main()
/dports/science/ergo/ergo-3.8/source/densfromf/recursive_expansion/eigenvectors/src/
H A Dget_eigenvectors.h64 VectorType y, Ay; in compute_rayleigh_quotient() local
69 Ay = ONE * A * y; // Ay = A*y in compute_rayleigh_quotient()
70 Treal lambda = transpose(y) * Ay; // lambda = y'*Ay in compute_rayleigh_quotient()
189 VectorType Ay; variable
200 Ay = y;
205 Ay = ONE * A * y; // Ay = A*y
209 y = Ay;
210 y *= ONE / Ay.eucl(); // y = Ay/norm(Ay)
211 Ay = ONE * A * y; // Ay = A*y
212 lambda = transpose(y) * Ay; // lambda = y'*Ay
[all …]
/dports/devel/godot2-tools/godot-2.1.6-stable/core/math/
H A Dtriangulate.cpp50 bool Triangulate::is_inside_triangle(float Ax, float Ay, in is_inside_triangle() argument
62 by = Ay - Cy; in is_inside_triangle()
64 cy = By - Ay; in is_inside_triangle()
66 apy = Py - Ay; in is_inside_triangle()
81 float Ax, Ay, Bx, By, Cx, Cy, Px, Py; in snip() local
85 Ay = contour[V[u]].y; in snip()
93 if (CMP_EPSILON > (((Bx - Ax) * (Cy - Ay)) - ((By - Ay) * (Cx - Ax)))) return false; in snip()
99 if (is_inside_triangle(Ax, Ay, Bx, By, Cx, Cy, Px, Py)) return false; in snip()
/dports/devel/godot2/godot-2.1.6-stable/core/math/
H A Dtriangulate.cpp50 bool Triangulate::is_inside_triangle(float Ax, float Ay, in is_inside_triangle() argument
62 by = Ay - Cy; in is_inside_triangle()
64 cy = By - Ay; in is_inside_triangle()
66 apy = Py - Ay; in is_inside_triangle()
81 float Ax, Ay, Bx, By, Cx, Cy, Px, Py; in snip() local
85 Ay = contour[V[u]].y; in snip()
93 if (CMP_EPSILON > (((Bx - Ax) * (Cy - Ay)) - ((By - Ay) * (Cx - Ax)))) return false; in snip()
99 if (is_inside_triangle(Ax, Ay, Bx, By, Cx, Cy, Px, Py)) return false; in snip()
/dports/comms/qt5-sensors/kde-qtsensors-5.15.2p2/src/plugins/sensors/android/
H A Dandroidcompass.cpp122 auto Ay = qreal(m_accelerometerEvent.y); in readAllEvents() local
125 const qreal normsqA = (Ax * Ax + Ay * Ay + Az * Az); in readAllEvents()
134 qreal Hx = Ey * Az - Ez * Ay; in readAllEvents()
136 qreal Hz = Ex * Ay - Ey * Ax; in readAllEvents()
145 const qreal invA = 1.0 / std::sqrt(Ax * Ax + Ay * Ay + Az * Az); in readAllEvents()
147 Ay *= invA; in readAllEvents()
/dports/devel/godot/godot-3.2.3-stable/core/math/
H A Dtriangulate.cpp51 bool Triangulate::is_inside_triangle(real_t Ax, real_t Ay, in is_inside_triangle() argument
64 by = Ay - Cy; in is_inside_triangle()
66 cy = By - Ay; in is_inside_triangle()
68 apy = Py - Ay; in is_inside_triangle()
87 real_t Ax, Ay, Bx, By, Cx, Cy, Px, Py; in snip() local
91 Ay = contour[V[u]].y; in snip()
106 if (threshold > (((Bx - Ax) * (Cy - Ay)) - ((By - Ay) * (Cx - Ax)))) return false; in snip()
112 if (is_inside_triangle(Ax, Ay, Bx, By, Cx, Cy, Px, Py, relaxed)) return false; in snip()
/dports/devel/godot-tools/godot-3.2.3-stable/core/math/
H A Dtriangulate.cpp51 bool Triangulate::is_inside_triangle(real_t Ax, real_t Ay, in is_inside_triangle() argument
64 by = Ay - Cy; in is_inside_triangle()
66 cy = By - Ay; in is_inside_triangle()
68 apy = Py - Ay; in is_inside_triangle()
87 real_t Ax, Ay, Bx, By, Cx, Cy, Px, Py; in snip() local
91 Ay = contour[V[u]].y; in snip()
106 if (threshold > (((Bx - Ax) * (Cy - Ay)) - ((By - Ay) * (Cx - Ax)))) return false; in snip()
112 if (is_inside_triangle(Ax, Ay, Bx, By, Cx, Cy, Px, Py, relaxed)) return false; in snip()
/dports/misc/vxl/vxl-3.3.2/contrib/brl/bbas/bmsh3d/algo/
H A Dbmsh3d_mesh_tri.cxx35 bool Triangulate::InsideTriangle(float Ax, float Ay, in InsideTriangle() argument
44 bx = Ax - Cx; by = Ay - Cy; in InsideTriangle()
45 cx = Bx - Ax; cy = By - Ay; in InsideTriangle()
46 apx= Px - Ax; apy= Py - Ay; in InsideTriangle()
60 float Ay = contour[V[u]].GetY(); in Snip() local
68 if ( EPSILON > (((Bx-Ax)*(Cy-Ay)) - ((By-Ay)*(Cx-Ax))) ) return false; in Snip()
76 if (InsideTriangle(Ax,Ay,Bx,By,Cx,Cy,Px,Py)) return false; in Snip()
/dports/math/py-or-tools/or-tools-9.2/ortools/flatzinc/mznlib/
H A Dnostrings.mzn46 array[int] of var int: Ay = str2ints(y);
55 array[int] of var int: Ay = str2ints(y);
64 array[int] of var int: Ay = str2ints(y);
88 array[int] of var int: Ay = str2ints(y);
100 array[int] of var int: Ay = str2ints(y);
102 Ay[1] = Ax[i]
104 Ay[1] = 0
117 i <= lx -> Ax[i] = Ay[lx - i + 1]
286 } in regular(Ay, Q, s + 1, dy, q0, F) /\
288 Ax[i] = if Ay[i] > 1 then map[Ay[i] - 1] else 0 endif
[all …]
/dports/math/e-antic/flint2-ae7ec89/fmpq_mat/
H A Dsolve_dixon.c28 fmpz_mat_t x, y, d, Ay; in _fmpq_mat_solve_dixon() local
45 fmpz_mat_init(Ay, n, cols); in _fmpq_mat_solve_dixon()
110 fmpz_mat_mul(Ay, A, y); in _fmpq_mat_solve_dixon()
119 fmpz_mat_set_nmod_mat(Ay, Ay_mod); in _fmpq_mat_solve_dixon()
124 fmpz_mat_CRT_ui(Ay, Ay, prod, Ay_mod, 1); in _fmpq_mat_solve_dixon()
131 fmpz_mat_sub(d, d, Ay); in _fmpq_mat_solve_dixon()
156 fmpz_mat_clear(Ay); in _fmpq_mat_solve_dixon()
/dports/math/e-antic/e-antic-1.0.0-rc.13/libeantic/upstream/antic/fmpq_mat/
H A Dsolve_dixon.c28 fmpz_mat_t x, y, d, Ay; in _fmpq_mat_solve_dixon() local
45 fmpz_mat_init(Ay, n, cols); in _fmpq_mat_solve_dixon()
110 fmpz_mat_mul(Ay, A, y); in _fmpq_mat_solve_dixon()
119 fmpz_mat_set_nmod_mat(Ay, Ay_mod); in _fmpq_mat_solve_dixon()
124 fmpz_mat_CRT_ui(Ay, Ay, prod, Ay_mod, 1); in _fmpq_mat_solve_dixon()
131 fmpz_mat_sub(d, d, Ay); in _fmpq_mat_solve_dixon()
156 fmpz_mat_clear(Ay); in _fmpq_mat_solve_dixon()
/dports/math/flint2/flint-2.8.4/fmpq_mat/
H A Dsolve_dixon.c28 fmpz_mat_t x, y, d, Ay; in _fmpq_mat_solve_dixon() local
45 fmpz_mat_init(Ay, n, cols); in _fmpq_mat_solve_dixon()
110 fmpz_mat_mul(Ay, A, y); in _fmpq_mat_solve_dixon()
119 fmpz_mat_set_nmod_mat(Ay, Ay_mod); in _fmpq_mat_solve_dixon()
124 fmpz_mat_CRT_ui(Ay, Ay, prod, Ay_mod, 1); in _fmpq_mat_solve_dixon()
131 fmpz_mat_sub(d, d, Ay); in _fmpq_mat_solve_dixon()
156 fmpz_mat_clear(Ay); in _fmpq_mat_solve_dixon()
/dports/graphics/photivo/photivo/Sources/filters/imagespot/
H A DptRepairSpot.cpp122 void ptRepairSpot::setPos(uint Ax, uint Ay) { in setPos() argument
124 Ay *= (1 << Settings->GetInt("PipeSize")); in setPos()
128 FRepairerPos.setY(FRepairerPos.y() + FPos.y() - Ay); in setPos()
131 FPos.setY(Ay); in setPos()
136 void ptRepairSpot::setRepairerPos(const uint Ax, const uint Ay) { in setRepairerPos() argument
139 FRepairerPos.setY(Ay * (1 << Settings->GetInt("PipeSize"))); in setRepairerPos()
144 void ptRepairSpot::setSpotPos(const uint Ax, const uint Ay) { in setSpotPos() argument
146 FPos.setY(Ay * (1 << Settings->GetInt("PipeSize"))); in setSpotPos()
/dports/math/freefem++/FreeFem-sources-4.6/examples/tutorial/
H A Dperiodic4bis.edp2 real Ax=0.9,Ay=1;
7 real gy = (Ay+By+Cy+Dy)/4.;
17 //mesh Th=square(10,10,[Cx*x*y+ Bx*(1-x)*y + Cx*(1-x)*(1-y) + Dx*(x)*(1-y),Ay*x*y+ By*(1-x)*y + Cy*…
20 real l1=dist(Ax,Ay,Bx,By);
23 real l4=dist(Dx,Dy,Ax,Ay);
24 func s1=dist(Ax,Ay,x,y)/l1;
32 << s4(Ax,Ay) << "\n ";
/dports/math/octave-forge-msh/msh/inst/
H A Dmsh2m_displacement_smoothing.m23 ## @deftypefn {Function File} {[@var{Ax},@var{Ay}]} = @
51 ## [Ax,Ay] = msh2m_displacement_smoothing(msh,1);
54 ## dy(varnodes) = Ay(varnodes,varnodes) \ ...
55 ## (-Ay(varnodes,dnodes)*dy(dnodes));
66 function [Ax,Ay] = msh2m_displacement_smoothing(msh, k)
88 Ay = spalloc(length(x),length(x),1); variable
115 Ay = sparse(ginode(:),gjnode(:),ay(:)); variable
141 %! [Ax,Ay] = msh2m_displacement_smoothing(msh,1);
145 %! dy(varnodes) = Ay(varnodes,varnodes) \ ...
146 %! (-Ay(varnodes,dnodes)*dy(dnodes));
/dports/cad/opencascade/opencascade-7.6.0/src/Bisector/
H A DBisector_FunctionH.cxx50 Standard_Real Ay = NormT2*t1.Y() - T2.Y(); in Value() local
52 F = (p1.X() - P2.X())*Ax + (p1.Y() - P2.Y())*Ay; in Value()
84 Standard_Real Ay = NormT2*t1.Y() - T2.Y(); in Values() local
86 F = (p1.X() - P2.X())*Ax + (p1.Y() - P2.Y())*Ay; in Values()
92 D = - T2.X()*Ax - T2.Y()*Ay + (p1.X() - P2.X())*dAx + (p1.Y() - P2.Y())*dAy; in Values()
/dports/games/toycars/toycars-0.3.10/toycars/src/Scoobie/
H A DScView.cpp147 …double Ax = -w*0.5, Ay = -h*0.5, Bx = w*0.5, By = -h*0.5, Cx = w*0.5, Cy = h*0.5, Dx = -w*0.5, Dy … in computeViewBoundingRect() local
149 Ax /= zoom; Ay /= zoom; in computeViewBoundingRect()
158 tempX = c*Ax - s*Ay; in computeViewBoundingRect()
159 tempY = s*Ax + c*Ay; in computeViewBoundingRect()
160 Ax = tempX; Ay = tempY; in computeViewBoundingRect()
176 outRect->bottom = fmin(fmin(Ay,By),fmin(Cy,Dy)); in computeViewBoundingRect()
177 outRect->top = fmax(fmax(Ay,By),fmax(Cy,Dy)); in computeViewBoundingRect()
/dports/math/e-antic/flint2-ae7ec89/fmpz_mat/
H A Dsolve_dixon.c97 fmpz_mat_t x, d, y, Ay; in _fmpz_mat_solve_dixon() local
113 fmpz_mat_init(Ay, n, cols); in _fmpz_mat_solve_dixon()
158 fmpz_mat_mul(Ay, A, y); in _fmpz_mat_solve_dixon()
167 fmpz_mat_set_nmod_mat(Ay, Ay_mod); in _fmpz_mat_solve_dixon()
172 fmpz_mat_CRT_ui(Ay, Ay, prod, Ay_mod, 1); in _fmpz_mat_solve_dixon()
179 fmpz_mat_sub(d, d, Ay); in _fmpz_mat_solve_dixon()
203 fmpz_mat_clear(Ay); in _fmpz_mat_solve_dixon()
/dports/math/flint2/flint-2.8.4/fmpz_mat/
H A Dsolve_dixon.c97 fmpz_mat_t x, d, y, Ay; in _fmpz_mat_solve_dixon() local
113 fmpz_mat_init(Ay, n, cols); in _fmpz_mat_solve_dixon()
158 fmpz_mat_mul(Ay, A, y); in _fmpz_mat_solve_dixon()
167 fmpz_mat_set_nmod_mat(Ay, Ay_mod); in _fmpz_mat_solve_dixon()
172 fmpz_mat_CRT_ui(Ay, Ay, prod, Ay_mod, 1); in _fmpz_mat_solve_dixon()
179 fmpz_mat_sub(d, d, Ay); in _fmpz_mat_solve_dixon()
203 fmpz_mat_clear(Ay); in _fmpz_mat_solve_dixon()
/dports/math/e-antic/e-antic-1.0.0-rc.13/libeantic/upstream/antic/fmpz_mat/
H A Dsolve_dixon.c97 fmpz_mat_t x, d, y, Ay; in _fmpz_mat_solve_dixon() local
113 fmpz_mat_init(Ay, n, cols); in _fmpz_mat_solve_dixon()
158 fmpz_mat_mul(Ay, A, y); in _fmpz_mat_solve_dixon()
167 fmpz_mat_set_nmod_mat(Ay, Ay_mod); in _fmpz_mat_solve_dixon()
172 fmpz_mat_CRT_ui(Ay, Ay, prod, Ay_mod, 1); in _fmpz_mat_solve_dixon()
179 fmpz_mat_sub(d, d, Ay); in _fmpz_mat_solve_dixon()
203 fmpz_mat_clear(Ay); in _fmpz_mat_solve_dixon()
/dports/comms/qt5-sensors/kde-qtsensors-5.15.2p2/src/plugins/sensors/generic/
H A Dgenerictiltsensor.cpp83 static inline qreal calcPitch(double Ax, double Ay, double Az) in calcPitch() argument
85 return qAtan2(-Ax, qSqrt(Ay * Ay + Az * Az)); in calcPitch()
91 static inline qreal calcRoll(double /*Ax*/, double Ay, double Az) in calcRoll() argument
93 return qAtan2(Ay, Az); in calcRoll()
/dports/math/fricas/fricas-1.3.7/src/graph/view3D/
H A Dmesh3d.c49 float Ax,Ay,Az,Bx,By,Bz, in getMeshNormal() local
52 Ax = x0-x1; Ay = y0-y1; Az = z0-z1; in getMeshNormal()
57 Normal[0] = (Ay*Bz - Az*By); in getMeshNormal()
59 Normal[2] = (Ax*By - Ay*Bx); in getMeshNormal()

12345678910>>...69