Home
last modified time | relevance | path

Searched refs:Vec1 (Results 1 – 25 of 441) sorted by relevance

12345678910>>...18

/dports/mail/thunderbird/thunderbird-91.8.0/third_party/highway/hwy/ops/
H A Dscalar-inl.h38 Vec1(const Vec1&) = default;
128 HWY_INLINE Vec1<T> And(const Vec1<T> a, const Vec1<T> b) { in And()
134 HWY_INLINE Vec1<T> operator&(const Vec1<T> a, const Vec1<T> b) {
141 HWY_INLINE Vec1<T> AndNot(const Vec1<T> a, const Vec1<T> b) { in AndNot()
150 HWY_INLINE Vec1<T> Or(const Vec1<T> a, const Vec1<T> b) { in Or()
163 HWY_INLINE Vec1<T> Xor(const Vec1<T> a, const Vec1<T> b) { in Xor()
363 HWY_INLINE Vec1<T> operator+(Vec1<T> a, Vec1<T> b) {
376 HWY_INLINE Vec1<T> operator-(Vec1<T> a, Vec1<T> b) {
474 HWY_INLINE Vec1<T> Min(const Vec1<T> a, const Vec1<T> b) { in Min()
479 HWY_INLINE Vec1<T> Min(const Vec1<T> a, const Vec1<T> b) { in Min()
[all …]
/dports/www/firefox-esr/firefox-91.8.0/third_party/highway/hwy/ops/
H A Dscalar-inl.h38 Vec1(const Vec1&) = default;
128 HWY_INLINE Vec1<T> And(const Vec1<T> a, const Vec1<T> b) { in And()
134 HWY_INLINE Vec1<T> operator&(const Vec1<T> a, const Vec1<T> b) {
141 HWY_INLINE Vec1<T> AndNot(const Vec1<T> a, const Vec1<T> b) { in AndNot()
150 HWY_INLINE Vec1<T> Or(const Vec1<T> a, const Vec1<T> b) { in Or()
163 HWY_INLINE Vec1<T> Xor(const Vec1<T> a, const Vec1<T> b) { in Xor()
363 HWY_INLINE Vec1<T> operator+(Vec1<T> a, Vec1<T> b) {
376 HWY_INLINE Vec1<T> operator-(Vec1<T> a, Vec1<T> b) {
474 HWY_INLINE Vec1<T> Min(const Vec1<T> a, const Vec1<T> b) { in Min()
479 HWY_INLINE Vec1<T> Min(const Vec1<T> a, const Vec1<T> b) { in Min()
[all …]
/dports/www/firefox/firefox-99.0/third_party/highway/hwy/ops/
H A Dscalar-inl.h36 Vec1(const Vec1&) = default;
144 HWY_API Vec1<T> And(const Vec1<T> a, const Vec1<T> b) { in And()
157 HWY_API Vec1<T> AndNot(const Vec1<T> a, const Vec1<T> b) { in AndNot()
167 HWY_API Vec1<T> Or(const Vec1<T> a, const Vec1<T> b) { in Or()
180 HWY_API Vec1<T> Xor(const Vec1<T> a, const Vec1<T> b) { in Xor()
193 HWY_API Vec1<T> OrAnd(const Vec1<T> o, const Vec1<T> a1, const Vec1<T> a2) { in OrAnd()
200 HWY_API Vec1<T> IfVecThenElse(Vec1<T> mask, Vec1<T> yes, Vec1<T> no) { in IfVecThenElse()
293 HWY_API Vec1<T> IfNegativeThenElse(Vec1<T> v, Vec1<T> yes, Vec1<T> no) { in IfNegativeThenElse()
420 HWY_API Vec1<T> operator+(Vec1<T> a, Vec1<T> b) {
433 HWY_API Vec1<T> operator-(Vec1<T> a, Vec1<T> b) {
[all …]
/dports/devel/highway/highway-0.15.0/hwy/ops/
H A Dscalar-inl.h36 Vec1(const Vec1&) = default;
144 HWY_API Vec1<T> And(const Vec1<T> a, const Vec1<T> b) { in And()
157 HWY_API Vec1<T> AndNot(const Vec1<T> a, const Vec1<T> b) { in AndNot()
167 HWY_API Vec1<T> Or(const Vec1<T> a, const Vec1<T> b) { in Or()
180 HWY_API Vec1<T> Xor(const Vec1<T> a, const Vec1<T> b) { in Xor()
401 HWY_API Vec1<T> operator+(Vec1<T> a, Vec1<T> b) {
414 HWY_API Vec1<T> operator-(Vec1<T> a, Vec1<T> b) {
510 HWY_API Vec1<T> Min(const Vec1<T> a, const Vec1<T> b) { in Min()
515 HWY_API Vec1<T> Min(const Vec1<T> a, const Vec1<T> b) { in Min()
606 HWY_API Vec1<T> MulAdd(const Vec1<T> mul, const Vec1<T> x, const Vec1<T> add) { in MulAdd()
[all …]
/dports/lang/gleam/gleam-0.18.2/cargo-crates/vec1-1.8.0/src/
H A Dlib.rs223 impl<T> Vec1<T> { implementation
244 Ok(Vec1(vec)) in from_vec()
350 Ok(Vec1(out)) in try_mapped()
373 Ok(Vec1(out)) in try_mapped_ref()
396 Ok(Vec1(out)) in try_mapped_mut()
414 Ok(Vec1(out)) in split_off()
436 Ok(Vec1(out)) in try_split_off()
483 impl Vec1<u8> { implementation
536 impl<A, B> PartialEq<Vec1<B>> for Vec1<A> implementation
679 impl io::Write for Vec1<u8> { implementation
[all …]
/dports/cad/opencascade/opencascade-7.6.0/src/Geom2dGcc/
H A DGeom2dGcc_FunctionTanCuPnt.cxx66 gp_Vec2d Vec1; in Derivative() local
70 Standard_Real NormeD1 = Vec1.Magnitude(); in Derivative()
74 (Vec1.Dot(Vec2)/(NormeD1*NormeD1)+ in Derivative()
75 Vec1.Dot(TheDirection)/(NormeDir*NormeDir)); in Derivative()
84 gp_Vec2d Vec1; in Values() local
86 Geom2dGcc_CurveTool::D2(TheCurv,X,Point,Vec1,Vec2); in Values()
88 Standard_Real NormeD1 = Vec1.Magnitude(); in Values()
90 Fval = TheDirection.Crossed(Vec1)/(NormeD1*NormeDir); in Values()
92 (TheDirection.Crossed(Vec1)/(NormeD1*NormeDir))* in Values()
93 (Vec1.Dot(Vec2)/(NormeD1*NormeD1)+ in Values()
[all …]
H A DGeom2dGcc_FunctionTanObl.cxx50 gp_Vec2d Vec1; in Derivative() local
52 Geom2dGcc_CurveTool::D2(TheCurv,X,Point,Vec1,Vec2); in Derivative()
53 Standard_Real NormeD1 = Vec1.Magnitude(); in Derivative()
55 Vec1.XY().Dot(Vec2.XY())*TheDirection.XY().Crossed(Vec1.XY())/NormeD1; in Derivative()
64 gp_Vec2d Vec1; in Values() local
66 Geom2dGcc_CurveTool::D2(TheCurv,X,Point,Vec1,Vec2); in Values()
67 Standard_Real NormeD1 = Vec1.Magnitude(); in Values()
68 Fval = TheDirection.XY().Crossed(Vec1.XY())/NormeD1; in Values()
70 Vec1.XY().Dot(Vec2.XY())*TheDirection.XY().Crossed(Vec1.XY())/NormeD1; in Values()
/dports/math/dune-istl/dune-istl-fffb544a61d2c65a0d2fc7c751f36909f06be8f5/dune/istl/test/
H A Dpreconditionerstest.cc23 using Vec1 = BlockVector<FieldVector<double,1>>; typedef
27 template class SeqJac<Mat1, Vec1, Vec1>;
28 template class SeqSOR<Mat1, Vec1, Vec1>;
29 template class SeqSSOR<Mat1, Vec1, Vec1>;
30 template class Richardson<Vec1, Vec1>;
31 template class SeqILU<Mat1, Vec1, Vec1>;
32 template class SeqILDL<Mat1, Vec1, Vec1>;
H A Dsolvertest.cc19 using Vec1 = BlockVector<FieldVector<double,1>>; typedef
25 template class InverseOperator<Vec1,Vec1>;
26 template class LoopSolver<Vec1>;
27 template class GradientSolver<Vec1>;
28 template class CGSolver<Vec1>;
29 template class BiCGSTABSolver<Vec1>;
30 template class MINRESSolver<Vec1>;
31 template class RestartedGMResSolver<Vec1>;
33 template class GeneralizedPCGSolver<Vec1>;
34 template class RestartedFCGSolver<Vec1>;
[all …]
/dports/science/PETSc/petsc-3.14.1/src/vec/vec/utils/
H A Dprojection.c32 VecCheckSameSize(Vec1,1,Vec2,2); in VecWhichEqual()
37 if (Vec1 == Vec2){ in VecWhichEqual()
51 if (Vec1 == Vec2){ in VecWhichEqual()
98 if (Vec1 == Vec2){ in VecWhichLessThan()
112 if (Vec1 == Vec2){ in VecWhichLessThan()
159 if (Vec1 == Vec2){ in VecWhichGreaterThan()
173 if (Vec1 == Vec2){ in VecWhichGreaterThan()
1000 if (Vec1==Vec2 || Vec1==Vec3){ in VecMedian()
1010 PetscValidType(Vec1,1); in VecMedian()
1028 if (Vec1 != VMedian){ in VecMedian()
[all …]
/dports/lang/rust/rustc-1.58.1-src/src/test/ui/
H A Dwrong-mul-method-signature.rs8 struct Vec1 { struct
13 impl Mul<f64> for Vec1 { implementation
14 type Output = Vec1;
16 fn mul(self, s: &f64) -> Vec1 { in mul() argument
18 Vec1 { in mul()
61 let x: Vec1 = Vec1 { x: 1.0 } * 2.0; // this is OK in main()
/dports/science/apbs/apbs-pdb2pqr-apbs-1.5-102-g500c1473/apbs/externals/fetk/mclite/
H A Dedgsplit.m30 % Vec1=zeros(1,3);
31 % Vec1(1:2)=V(1:2);
32 % Vec1=R*Vec1*(1/norm(Vec1));
33 % Vec2=V-Vec1;
35 % V=Vec1+Vec2;
/dports/math/dune-localfunctions/dune-localfunctions-f6628171b2773065ab43f97a77f47cd8c4283d8f/dune/localfunctions/utility/
H A Dtensor.hh568 template <class Vec1,class Vec2,unsigned int deriv>
573 const Vec1 &x, Vec2 &y) in apply()
587 const Vec1 &x, Vec2 &y) in apply()
603 const Vec1 &x, Vec2 &y) in apply()
619 const Vec1 &x, Vec2 &y) in apply()
634 const Vec1 &x, Vec2 &y) in apply()
647 template <class Vec1,class Vec2>
660 typedef Derivatives<F1,dimD,dimR,deriv,layout> Vec1; typedef
696 typedef Derivatives<F1,dimD,1,deriv,layout> Vec1; typedef
708 typedef Derivatives<F1,dimD,1,deriv,layout> Vec1; typedef
[all …]
/dports/science/openmx/openmx3.8/source/
H A DTRAN_Calc_GridBound.c63 double coef,Vec0,Vec1; in TRAN_Calc_GridBound() local
121 Vec1 = Dot_Product(Cxyz,rgtv[1])*0.5/PI; in TRAN_Calc_GridBound()
124 if (Vec1<MinV) MinV = Vec1; in TRAN_Calc_GridBound()
126 if (MaxV<Vec1) MaxV = Vec1; in TRAN_Calc_GridBound()
202 Vec1 = Dot_Product(Cxyz,rgtv[1])*0.5/PI; in TRAN_Calc_GridBound()
205 if (Vec1<MinV) MinV = Vec1; in TRAN_Calc_GridBound()
207 if (MaxV<Vec1) MaxV = Vec1; in TRAN_Calc_GridBound()
/dports/games/dustrac/DustRacing2D-ae380b8/src/game/MiniCore/src/Graphics/contrib/glm/ogl-math/glm/core/
H A Dintrinsic_matrix.inl395 // - (Vec1[0] * Fac2[0] - Vec1[0] * Fac4[0] + Vec2[0] * Fac5[0]),
396 // + (Vec1[0] * Fac2[1] - Vec1[1] * Fac4[1] + Vec2[1] * Fac5[1]),
397 // - (Vec1[0] * Fac2[2] - Vec1[2] * Fac4[2] + Vec2[2] * Fac5[2]),
398 // + (Vec1[0] * Fac2[3] - Vec1[3] * Fac4[3] + Vec2[3] * Fac5[3]));
741 // - (Vec1[0] * Fac2[0] - Vec1[0] * Fac4[0] + Vec2[0] * Fac5[0]),
742 // + (Vec1[0] * Fac2[1] - Vec1[1] * Fac4[1] + Vec2[1] * Fac5[1]),
743 // - (Vec1[0] * Fac2[2] - Vec1[2] * Fac4[2] + Vec2[2] * Fac5[2]),
744 // + (Vec1[0] * Fac2[3] - Vec1[3] * Fac4[3] + Vec2[3] * Fac5[3]));
962 // - (Vec1[0] * Fac2[0] - Vec1[0] * Fac4[0] + Vec2[0] * Fac5[0]),
963 // + (Vec1[0] * Fac2[1] - Vec1[1] * Fac4[1] + Vec2[1] * Fac5[1]),
[all …]
/dports/math/amgcl/amgcl-1.4.2/amgcl/mpi/
H A Dinner_product.hpp49 template <class Vec1, class Vec2>
51 typename backend::value_type<Vec1>::type
53 operator()(const Vec1 &x, const Vec2 &y) const { in operator ()()
54 typedef typename backend::value_type<Vec1>::type value_type; in operator ()()
H A Dsubdomain_deflation.hpp80 template <class T, class Vec1, class Vec2>
81 void mul(T alpha, const Vec1 &x, T beta, Vec2 &y) const { in mul()
89 template <class Vec1, class Vec2, class Vec3>
458 template <class Vec1, class Vec2>
459 void apply(const Vec1 &rhs, Vec2 &&x) const { in apply()
474 template <class Matrix, class Vec1, class Vec2>
483 template <class Vec1, class Vec2>
485 operator()(const Vec1 &rhs, Vec2 &&x) const { in operator ()()
546 template <class Vec1, class Vec2>
547 void postprocess(const Vec1 &rhs, Vec2 &x) const { in postprocess()
[all …]
/dports/math/amgcl/amgcl-1.4.2/amgcl/
H A Dmake_block_solver.hpp41 template <class Matrix, class Vec1, class Vec2>
43 const Matrix &A, const Vec1 &rhs, Vec2 &&x) const in operator ()()
45 …typedef typename math::scalar_of<typename backend::value_type<typename std::decay<Vec1>::type>::ty… in operator ()()
57 template <class Vec1, class Vec2>
59 operator()(const Vec1 &rhs, Vec2 &&x) const { in operator ()()
60 …typedef typename math::scalar_of<typename backend::value_type<typename std::decay<Vec1>::type>::ty… in operator ()()
H A Dmake_solver.hpp128 template <class Matrix, class Vec1, class Vec2>
130 const Matrix &A, const Vec1 &rhs, Vec2 &&x) const in operator ()()
140 template <class Vec1, class Vec2>
141 std::tuple<size_t, scalar_type> operator()(const Vec1 &rhs, Vec2 &&x) const { in operator ()()
169 template <class Vec1, class Vec2>
170 void apply(const Vec1 &rhs, Vec2 &&x) const { in apply()
/dports/science/simbody/simbody-Simbody-3.7/SimTKmath/Geometry/src/
H A DGCVSPLUtil.cpp29 …cvspl(x, reinterpret_cast<const Vector_<Vec1>&>(y), wx, Vec1(wy), degree, md, val, reinterpret_cas… in gcvspl()
33 return splder(derivOrder, degree, t, x, reinterpret_cast<const Vector_<Vec1>&>(coeff))[0]; in splder()
/dports/cad/opencascade/opencascade-7.6.0/inc/
H A DBSplCLib.lxx114 gp_Vec& Vec1,
118 P, Vec1, Vec2);
130 gp_Vec2d& Vec1,
134 P, Vec1, Vec2);
146 gp_Vec& Vec1,
151 P, Vec1, Vec2, Vec3);
163 gp_Vec2d& Vec1,
168 P, Vec1, Vec2, Vec3);
/dports/cad/opencascade/opencascade-7.6.0/src/BSplCLib/
H A DBSplCLib.lxx114 gp_Vec& Vec1,
118 P, Vec1, Vec2);
130 gp_Vec2d& Vec1,
134 P, Vec1, Vec2);
146 gp_Vec& Vec1,
151 P, Vec1, Vec2, Vec3);
163 gp_Vec2d& Vec1,
168 P, Vec1, Vec2, Vec3);
/dports/devel/py-cadquery-pywrap/pywrap-e8c7bc9/opencascade/
H A DBSplCLib.lxx114 gp_Vec& Vec1,
118 P, Vec1, Vec2);
130 gp_Vec2d& Vec1,
134 P, Vec1, Vec2);
146 gp_Vec& Vec1,
151 P, Vec1, Vec2, Vec3);
163 gp_Vec2d& Vec1,
168 P, Vec1, Vec2, Vec3);
/dports/math/stanmath/math-4.2.0/stan/math/prim/fun/
H A Ddot_product.hpp21 template <typename Vec1, typename Vec2,
22 require_all_eigen_vector_t<Vec1, Vec2> * = nullptr,
23 require_not_var_t<return_type_t<Vec1, Vec2>> * = nullptr>
24 inline auto dot_product(const Vec1 &v1, const Vec2 &v2) { in dot_product()
/dports/science/PETSc/petsc-3.14.1/src/vec/vec/utils/ftn-auto/
H A Dprojectionf.c112 PETSC_EXTERN void vecwhichequal_(Vec Vec1,Vec Vec2,IS *S, int *__ierr) in vecwhichequal_() argument
115 (Vec)PetscToPointer((Vec1) ), in vecwhichequal_()
118 PETSC_EXTERN void vecwhichlessthan_(Vec Vec1,Vec Vec2,IS *S, int *__ierr) in vecwhichlessthan_() argument
121 (Vec)PetscToPointer((Vec1) ), in vecwhichlessthan_()
124 PETSC_EXTERN void vecwhichgreaterthan_(Vec Vec1,Vec Vec2,IS *S, int *__ierr) in vecwhichgreaterthan_() argument
127 (Vec)PetscToPointer((Vec1) ), in vecwhichgreaterthan_()
207 PETSC_EXTERN void vecmedian_(Vec Vec1,Vec Vec2,Vec Vec3,Vec VMedian, int *__ierr) in vecmedian_() argument
210 (Vec)PetscToPointer((Vec1) ), in vecmedian_()

12345678910>>...18