Home
last modified time | relevance | path

Searched refs:axpy (Results 1 – 25 of 1258) sorted by relevance

12345678910>>...51

/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/trilinos/packages/rol/src/step/interiorpoint/
H A DROL_ObjectiveFromBoundConstraint.hpp160 a_->axpy(-one,*lo_); // a = x-l in value()
166 b_->axpy(-one,x); // b = u-x in value()
179 a_->axpy(-one,*lo_); // a = x-l in value()
186 b_->axpy(-one,x); // b = u-x in value()
321 a_->axpy(-one,*lo_); // a = x-l in hessVec()
328 b_->axpy(-one,x); // b = u-x in hessVec()
341 a_->axpy(-one,x); // a = l-x in hessVec()
347 b_->axpy(-one,*up_); // b = x-u in hessVec()
360 a_->axpy(-one,*lo_); // a = x-l in hessVec()
363 b_->axpy(-one,x); // b = u-x in hessVec()
[all …]
H A DROL_InteriorPointPenalty.hpp243 a_->axpy(-1.0,*lo_); // a_i = x_i-l_i in value()
308 a_->axpy(-1.0,*lo_); // a = x-l in gradient()
314 b_->axpy(-1.0,x); // b = u-x in gradient()
318 g.axpy(-mu_,*a_); in gradient()
319 g.axpy(mu_,*b_); in gradient()
329 g.axpy(-mu_*kappaD_,*a_); in gradient()
330 g.axpy( mu_*kappaD_,*b_); in gradient()
353 a_->axpy(-1.0,*lo_); // a = x-l in hessVec()
361 b_->axpy(-1.0,x); // b = u-x in hessVec()
368 hv.axpy(mu_,*a_); in hessVec()
[all …]
/dports/science/siconos/siconos-4.4.0/externals/numeric_bindings/boost/numeric/bindings/blas/level1/
H A Daxpy.hpp74 inline void axpy( const int n, const double a, const double* x, in axpy() function
84 inline void axpy( const int n, const std::complex<float> a, in axpy() function
95 inline void axpy( const int n, const std::complex<double> a, in axpy() function
117 inline void axpy( const int n, const double a, const double* x,
127 inline void axpy( const int n, const std::complex<float> a,
138 inline void axpy( const int n, const std::complex<double> a,
150 inline void axpy( const fortran_int_t n, const float a, const float* x,
170 inline void axpy( const fortran_int_t n, const std::complex<float> a,
181 inline void axpy( const fortran_int_t n, const std::complex<double> a,
218 detail::axpy( bindings::size(x), a, bindings::begin_value(x), in invoke()
[all …]
/dports/math/cgal/CGAL-5.3/include/CGAL/OpenNL/
H A Dbicgstab.h109 BLAS<Vector>::axpy(-1,b,r); in solve()
122 BLAS<Vector>::axpy(-alpha,Ad,r); in solve()
126 BLAS<Vector>::axpy(1,t,u); in solve()
134 BLAS<Vector>::axpy(-omega,t,r); in solve()
135 BLAS<Vector>::axpy(-alpha,d,x); in solve()
136 BLAS<Vector>::axpy(-omega,s,x); in solve()
139 BLAS<Vector>::axpy(-omega,t,h); in solve()
158 BLAS<Vector>::axpy(1,h,d); in solve()
251 BLAS<Vector>::axpy(-1,b,r); in solve()
276 BLAS<Vector>::axpy(1,t,u); in solve()
[all …]
H A Dconjugate_gradient.h106 BLAS<Vector>::axpy(-1,b,g); in solve()
119 BLAS<Vector>::axpy(t,r,x); in solve()
120 BLAS<Vector>::axpy(-t,p,g); in solve()
124 BLAS<Vector>::axpy(1,g,r); in solve()
207 BLAS<Vector>::axpy(-1,b,r); in solve()
217 BLAS<Vector>::axpy(-alpha,d,x); in solve()
218 BLAS<Vector>::axpy(-alpha,Ad,r); in solve()
223 BLAS<Vector>::axpy(1,h,d); in solve()
/dports/science/qmcpack/qmcpack-3.11.0/external_codes/boost_multi/multi/adaptors/blas/
H A Daxpy.hpp14 using core::axpy;
18 ->decltype(axpy(n, &alpha, first.base(), first.stride(), d_first.base(), d_first.stride()), d_first… in axpy_n()
19 …return axpy(n, &alpha, base(first) , stride(first) , base(d_first) , stride(d_first) ) , d_first +… in axpy_n()
24 …return std::forward<Context>(ctxt).axpy(n, &alpha, base(first) , stride(first) , base(d_first) , s… in axpy_n()
27 auto axpy(typename X1D::element alpha, X1D const& x, Y1D&& y) in axpy() function
33 auto axpy(Context&& ctxt, typename X1D::element alpha, X1D const& x, Y1D&& y) in axpy() function
39 Y1D&& axpy(X1D const& x, Y1D&& y){return axpy(+1., x, std::forward<Y1D>(y));} in axpy() function
42 Y1D&& axpy(Context&& ctxt, X1D const& x, Y1D&& y){return axpy(std::forward<Context>(ctxt), +1., x, … in axpy() function
70 axpy_range<Context, Scale, typename X::const_iterator> axpy(Context&& ctxt, Scale a, X const& x){ in axpy() function
78 template<class X1D, class Y1D> auto operator+=(X1D&& x, Y1D const& other) DECLRETURN(axpy(+1., othe…
[all …]
/dports/math/blaze/blaze-3.8/blaze/math/blas/cblas/
H A Daxpy.h62 void axpy( blas_int_t n, float alpha, const float* x, blas_int_t incX,
65 void axpy( blas_int_t n, double alpha, const double* x, blas_int_t incX,
68 void axpy( blas_int_t n, complex<float> alpha, const complex<float>* x, blas_int_t incX,
71 void axpy( blas_int_t n, complex<double> alpha, const complex<double>* x, blas_int_t incX,
100 inline void axpy( blas_int_t n, float alpha, const float* x, blas_int_t incX, in axpy() function
130 inline void axpy( blas_int_t n, double alpha, const double* x, blas_int_t incX, in axpy() function
160 inline void axpy( blas_int_t n, complex<float> alpha, const complex<float>* x, blas_int_t incX, in axpy() function
193 inline void axpy( blas_int_t n, complex<double> alpha, const complex<double>* x, blas_int_t incX, in axpy() function
/dports/science/siconos/siconos-4.4.0/externals/numeric_bindings/libs/numeric/bindings/doc/blas/level1/
H A Daxpy.qbk7 [section axpy]
10 There are two prototypes of `axpy` available, please see below.
12 axpy( const Scalar >, const VectorX& x, VectorY& y );
16 axpy( const Scalar a, const VectorX& x, VectorY& y );
22 `axpy` (short for a times x plus y) provides a C++
32 [table Dispatching of axpy.
42 whereas `axpy` requires three arguments.
44 [table Deduction of arguments of axpy.
48 Defined in header [headerref boost/numeric/bindings/blas/level1/axpy.hpp].
66 #include <boost/numeric/bindings/blas/level1/axpy.hpp>
[all …]
/dports/math/dune-fem/dune-fem-d1c625e6d51167d0cce57de6adcef21f548a8f82/dune/fem/space/basisfunctionset/
H A Dsimple.hh88 void axpy ( const Quadrature &quad, const Vector &values, DofVector &dofs ) const in axpy() function in Dune::Fem::SimpleBasisFunctionSet
92 axpy( quad[ qp ], values[ qp ], dofs ); in axpy()
102 …void axpy ( const Quadrature &quad, const VectorA &valuesA, const VectorB &valuesB, DofVector &dof… in axpy() function in Dune::Fem::SimpleBasisFunctionSet
107 axpy( quad[ qp ], valuesA[ qp ], dofs ); in axpy()
108 axpy( quad[ qp ], valuesB[ qp ], dofs ); in axpy()
116 void axpy ( const Point &x, const RangeType &valueFactor, DofVector &dofs ) const in axpy() function in Dune::Fem::SimpleBasisFunctionSet
126 void axpy ( const Point &x, const JacobianRangeType &jacobianFactor, DofVector &dofs ) const in axpy() function in Dune::Fem::SimpleBasisFunctionSet
134 void axpy ( const Point &x, const HessianRangeType &hessianFactor, DofVector &dofs ) const in axpy() function in Dune::Fem::SimpleBasisFunctionSet
144 void axpy ( const Point &x, const RangeType &valueFactor, in axpy() function in Dune::Fem::SimpleBasisFunctionSet
148 axpy( x, valueFactor, dofs ); in axpy()
[all …]
H A Dfunctor.hh20 inline void axpy ( const T &a, const T &x, T &y );
23 inline void axpy ( const typename FieldTraits< K >::field_type &a,
28 inline void axpy ( const typename FieldTraits< K >::field_type &a,
38 inline void axpy ( const T &a, const T &x, T &y ) in axpy() function
44 inline void axpy ( const typename FieldTraits< K >::field_type &a, in axpy() function
49 axpy( a, x[ i ], y[ i ] ); in axpy()
53 inline void axpy ( const typename FieldTraits< K >::field_type &a, in axpy() function
57 y.axpy( a, x ); in axpy()
117 axpy( vector_[ i ], v, value_ ); in operator ()()
H A Dtransformed.hh108 void axpy ( const QuadratureType &quad, const Vector &values, DofVector &dofs ) const in axpy() function in Dune::Fem::TransformedBasisFunctionSet
113 axpy( quad[ qp ], values[ qp ], dofs ); in axpy()
123 …void axpy ( const QuadratureType &quad, const VectorA &valuesA, const VectorB &valuesB, DofVector … in axpy() function in Dune::Fem::TransformedBasisFunctionSet
129 axpy( quad[ qp ], valuesA[ qp ], dofs ); in axpy()
130 axpy( quad[ qp ], valuesB[ qp ], dofs ); in axpy()
138 void axpy ( const Point &x, const RangeType &valueFactor, DofVector &dofs ) const in axpy() function in Dune::Fem::TransformedBasisFunctionSet
149 void axpy ( const Point &x, const JacobianRangeType &jacobianFactor, DofVector &dofs ) const in axpy() function in Dune::Fem::TransformedBasisFunctionSet
167 void axpy( const Point &x, const HessianRangeType &hessianFactor, DofVector &dofs ) const in axpy() function in Dune::Fem::TransformedBasisFunctionSet
176 … void axpy ( const Point &x, const RangeType &valueFactor, const JacobianRangeType &jacobianFactor, in axpy() function in Dune::Fem::TransformedBasisFunctionSet
179 axpy( x, valueFactor, dofs ); in axpy()
[all …]
/dports/science/py-scipy/scipy-1.7.1/scipy/sparse/linalg/isolve/
H A D_gcrotmk.py116 w = axpy(c, w, c.shape[0], -alpha) # w -= alpha*c
123 w = axpy(v, w, v.shape[0], -alpha) # w -= alpha*v
288 axpy, dot, scal = None, None, None
329 u = axpy(us[P[i]], u, u.shape[0], -R[i,j])
340 axpy, dot = get_blas_funcs(['axpy', 'dot'], (r,))
352 x = axpy(u, x, x.shape[0], yc)
353 r = axpy(c, r, r.shape[0], -yc)
414 ux = axpy(z, ux, ux.shape[0], yc) # ux += z*yc
442 x = axpy(ux, x, x.shape[0], gamma) # x += gamma*ux
462 c = axpy(cp, c, c.shape[0], wp)
[all …]
/dports/math/dune-fem/dune-fem-d1c625e6d51167d0cce57de6adcef21f548a8f82/dune/fem/function/localfunction/
H A Dlocalfunction.hh214 localDofVector().axpy( s, other.localDofVector() );
218 using BaseType :: axpy;
233 void axpy ( const PointType &x, const RangeType &factor ) in axpy() function in Dune::Fem::LocalFunction
235 basisFunctionSet().axpy( x, factor, localDofVector() ); in axpy()
251 void axpy ( const PointType &x, const JacobianRangeType &factor) in axpy() function in Dune::Fem::LocalFunction
253 basisFunctionSet().axpy( x, factor, localDofVector() ); in axpy()
256 void axpy ( const PointType &x, const HessianRangeType &factor) in axpy() function in Dune::Fem::LocalFunction
258 basisFunctionSet().axpy( x, factor, localDofVector() ); in axpy()
277 basisFunctionSet().axpy( x, factor1, factor2, localDofVector() ); in axpy()
369 std::make_tuple( ( basisFunctionSet().axpy( quad, values, localDofVector() ), 1 )...); in axpyQuadrature()
[all …]
/dports/science/qmcpack/qmcpack-3.11.0/external_codes/boost_multi/multi/adaptors/blas/test/
H A Daxpy.cpp27 blas::axpy(2., B, A[1]); // daxpy in BOOST_AUTO_TEST_CASE()
40 blas::axpy(2., b, A[1]); // A[1] = 2*b + A[1], A[1]+= a*A[1] in BOOST_AUTO_TEST_CASE()
47 blas::axpy(+1., blas::real(AC), blas::real(BC)); in BOOST_AUTO_TEST_CASE()
48 blas::axpy(-1., blas::imag(AC), blas::imag(BC)); in BOOST_AUTO_TEST_CASE()
63 blas::axpy(2., B, A[1]); // zaxpy (2. is promoted to 2+I*0 internally and automatically) in BOOST_AUTO_TEST_CASE()
77 A[1] += blas::axpy(2., B); // zaxpy (2. is promoted to 2+I*0 internally and automatically) in BOOST_AUTO_TEST_CASE()
90 A[1] -= blas::axpy(2., B); // zaxpy (2. is promoted to 2+I*0 internally and automatically) in BOOST_AUTO_TEST_CASE()
103 …blas::axpy(blas::context{}, 2., B, A[1]); // zaxpy (2. is promoted to 2+I*0 internally and automat… in BOOST_AUTO_TEST_CASE()
145 blas::axpy(2., B, A[1]); // zaxpy (2. is promoted to 2+I*0 internally and automatically) in BOOST_AUTO_TEST_CASE()
/dports/math/dune-fem/dune-fem-d1c625e6d51167d0cce57de6adcef21f548a8f82/dune/fem/space/finitevolume/
H A Dbasisfunctionset.hh71 void axpy ( const Quadrature &quadrature, const Vector &values, DofVector &dofs ) const in axpy() function
75 axpy( quadrature[ qp ], values[ qp ], dofs ); in axpy()
80 …void axpy ( const Quadrature &quadrature, const VectorA &valuesA, const VectorB &valuesB, DofVecto… in axpy() function
85 axpy( quadrature[ qp ], valuesA[ qp ], dofs ); in axpy()
86 axpy( quadrature[ qp ], valuesB[ qp ], dofs ); in axpy()
92 void axpy ( const Point &x, const RangeType &valueFactor, DofVector &dofs ) const in axpy() function
100 void axpy ( const Point &x, const JacobianRangeType &jacobianFactor, DofVector &dofs ) const in axpy() function
105 … void axpy ( const Point &x, const RangeType &valueFactor, const JacobianRangeType &jacobianFactor, in axpy() function
108 axpy( x, valueFactor, dofs ); in axpy()
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/trilinos/packages/rol/src/function/
H A DROL_ObjectiveMMA.hpp120 d_->axpy(-1.0,*l_); in update()
125 d_->axpy(-1.0,x); in update()
141 d_->axpy(-1.0,x); in value()
147 d_->axpy(-1.0,*l_); in value()
165 d_->axpy(-1.0,x); in gradient()
172 d_->axpy(-1.0,*l_); in gradient()
187 d_->axpy(-1.0,x); in hessVec()
195 d_->axpy(-1.0,*l_); in hessVec()
212 d_->axpy(-1.0,x); in invHessVec()
220 d_->axpy(-1.0,*l_); in invHessVec()
/dports/science/py-scipy/scipy-1.7.1/scipy/linalg/
H A Dcblas_l1.pyf.src8 ! axpy
12 subroutine <prefix>axpy(n,a,x,incx,y,incy)
14 ! z = axpy(a,x,y,n=len(x)/abs(incx),incx=1,incy=incx,overwrite_y=0)
17 fortranname cblas_<prefix>axpy
23 intent(c) <prefix>axpy
33 end subroutine <prefix>axpy
/dports/math/xtensor-blas/xtensor-blas-0.20.0/include/xflens/cxxblas/level1/
H A Daxpy.h45 axpy(IndexType n, const ALPHA &alpha, const X *x, IndexType incX,
52 axpy(IndexType n, const float &alpha,
59 axpy(IndexType n, const double &alpha,
66 axpy(IndexType n, const ComplexFloat &alpha,
73 axpy(IndexType n, const ComplexDouble &alpha,
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/trilinos/packages/rol/src/step/nonlinearcg/
H A DROL_NonlinearCG.hpp139 y_->axpy(-one, *(state_->grad[0])); in run()
160 y_->axpy(-one, *(state_->grad[0])); in run()
173 y_->axpy(-one, *(state_->grad[0])); in run()
181 y_->axpy(-one, *(state_->grad[0])); in run()
189 y_->axpy(-one, *(state_->grad[0])); in run()
192 yd_->axpy(-mult, (state_->pstep[0])->dual()); in run()
202 y_->axpy(-one, *(state_->grad[0])); in run()
205 yd_->axpy(-mult, (state_->pstep[0])->dual()); in run()
218 s.axpy(beta, *(state_->pstep[0])); in run()
/dports/devel/py-numba/numba-0.51.2/numba/roc/tests/hsapy/
H A Dtest_ufuncbuilding.py47 def axpy(a, x, y): function
51 self.assertIsInstance(axpy, HsaUFuncDispatcher)
57 got = axpy(A, X, Y)
68 got = axpy(A, X, Y)
80 def axpy(a, x, y): function
83 self.assertIsInstance(axpy, HsaUFuncDispatcher)
89 got = axpy(A, X, Y)
100 got = axpy(A, X, Y)
/dports/science/octopus/octopus-10.5/testsuite/components/
H A D26-batch_ops.test10 match ; Norm state axpy 1; GREPFIELD(out, 'Norm state axpy 1', 5) ; 0.150000E+01
11 match ; Norm state axpy 2; GREPFIELD(out, 'Norm state axpy 2', 5) ; 0.150000E+01
12 match ; Norm state axpy 3; GREPFIELD(out, 'Norm state axpy 3', 5) ; 0.150000E+01
13 match ; Norm state axpy 4; GREPFIELD(out, 'Norm state axpy 4', 5) ; 0.150000E+01
56 match ; Norm state axpy 1; GREPFIELD(out, 'Norm state axpy 1', 5) ; 0.150000E+01
57 match ; Norm state axpy 2; GREPFIELD(out, 'Norm state axpy 2', 5) ; 0.150000E+01
58 match ; Norm state axpy 3; GREPFIELD(out, 'Norm state axpy 3', 5) ; 0.150000E+01
59 match ; Norm state axpy 4; GREPFIELD(out, 'Norm state axpy 4', 5) ; 0.150000E+01
109 match ; Norm state axpy 1; GREPFIELD(out, 'Norm state axpy 1', 5) ; 0.150000E+01
110 match ; Norm state axpy 2; GREPFIELD(out, 'Norm state axpy 2', 5) ; 0.150000E+01
[all …]
/dports/math/arpack++/arpackpp-2.3.0/examples/areig/nonsym/
H A Dansymsol.h78 axpy(n, -EigValR[i], &EigVec[i*n], 1, Ax, 1);
85 axpy(n, -EigValR[i], &EigVec[i*n], 1, Ax, 1);
86 axpy(n, EigValI[i], &EigVec[(i+1)*n], 1, Ax, 1);
89 axpy(n, -EigValI[i], &EigVec[i*n], 1, Ax, 1);
90 axpy(n, -EigValR[i], &EigVec[(i+1)*n], 1, Ax, 1);
172 axpy(n, -EigValR[i], Bx, 1, Ax, 1);
181 axpy(n, -EigValR[i], Bx, 1, Ax, 1);
182 axpy(n, EigValI[i], Bx1, 1, Ax, 1);
185 axpy(n, -EigValI[i], Bx, 1, Ax, 1);
186 axpy(n, -EigValR[i], Bx1, 1, Ax, 1);
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/external/trilinos/packages/rol/src/vector/
H A DROL_Vector.hpp153 virtual void axpy( const Real alpha, const Vector &x ) { in axpy() function in ROL::Vector
346 v->plus(x); xtmp->plus(*this); v->axpy(-one, *xtmp); vCheck.push_back(v->norm()); in checkVector()
352 …ytmp->plus(x); v->plus(*ytmp); xtmp->plus(*this); xtmp->plus(y); v->axpy(-one, *xtmp); vCheck.push… in checkVector()
357 v->zero(); v->plus(x); v->axpy(-one, x); vCheck.push_back(v->norm()); in checkVector()
367 v->scale(one); v->axpy(-one, *this); vCheck.push_back(v->norm()); in checkVector()
372 v->scale(b); v->scale(a); vtmp->scale(a*b); v->axpy(-one, *vtmp); vCheck.push_back(v->norm()); in checkVector()
377 …v->scale(a+b); vtmp->scale(a); vtmp->axpy(b, *this); v->axpy(-one, *vtmp); vCheck.push_back(v->nor… in checkVector()
382 …v->plus(x); v->scale(a); xtmp->scale(a); xtmp->axpy(a, *this); v->axpy(-one, *xtmp); vCheck.push_b… in checkVector()
410 v->axpy(-one, *ytmp); vCheck.push_back(v->norm()); in checkVector()
/dports/math/arpack++/arpackpp-2.3.0/examples/matrices/nonsym/
H A Dlnsymsol.h103 axpy(n, -Prob.EigenvalueReal(i), Prob.RawEigenvector(i), 1, Ax, 1); in Solution()
110 axpy(n, -Prob.EigenvalueReal(i), Prob.RawEigenvector(i), 1, Ax, 1); in Solution()
111 axpy(n, Prob.EigenvalueImag(i), Prob.RawEigenvector(i+1), 1, Ax, 1); in Solution()
114 axpy(n, -Prob.EigenvalueImag(i), Prob.RawEigenvector(i), 1, Ax, 1); in Solution()
115 axpy(n, -Prob.EigenvalueReal(i), Prob.RawEigenvector(i+1), 1, Ax, 1); in Solution()
211 axpy(n, -Prob.EigenvalueReal(i), Bx, 1, Ax, 1); in Solution()
220 axpy(n, -Prob.EigenvalueReal(i), Bx, 1, Ax, 1); in Solution()
221 axpy(n, Prob.EigenvalueImag(i), Bx1, 1, Ax, 1); in Solution()
224 axpy(n, -Prob.EigenvalueImag(i), Bx, 1, Ax, 1); in Solution()
225 axpy(n, -Prob.EigenvalueReal(i), Bx1, 1, Ax, 1); in Solution()
/dports/math/xtensor-blas/xtensor-blas-0.20.0/include/xflens/cxxblas/level1extensions/
H A Daxpy.h46 axpy(IndexType n, const float &alpha,
52 axpy(IndexType n, const std::complex<float> &alpha,
58 axpy(IndexType n, const double &alpha,
64 axpy(IndexType n, const std::complex<double> &alpha,

12345678910>>...51