HomeSort by relevance Sort by last modified time
    Searched refs:Scalar (Results 401 - 425 of 600) sorted by null

<<11121314151617181920>>

  /external/deqp/modules/gles31/scripts/
gen-implicit-conversions.py 7 from genutil import Scalar, Vec2, Vec3, Vec4, Uint, UVec2, UVec3, UVec4, CaseGroup
211 "int": [Scalar(x) for x in IN_ISCALAR],
212 "uint": [Scalar(x) for x in IN_USCALAR],
219 "float": [Scalar(x).toFloat() for x in IN_ISCALAR],
280 if isinstance(a, Scalar) and isinstance(b, Vec2):
282 elif isinstance(a, Scalar) and isinstance(b, Vec3):
284 elif isinstance(a, Scalar) and isinstance(b, Vec4):
298 if isinstance(value, Scalar):
358 "float": Scalar(2.0),
399 if isinstance(a, Scalar) and isinstance(b, Scalar)
    [all...]
  /external/eigen/Eigen/src/SparseLU/
SparseLU_panel_dfs.h 40 typedef typename IndexVector::Scalar Index;
60 template <typename Scalar, typename Index>
62 void SparseLUImpl<Scalar,Index>::dfs_kernel(const Index jj, IndexVector& perm_r,
218 template <typename Scalar, typename Index>
219 void SparseLUImpl<Scalar,Index>::panel_dfs(const Index m, const Index w, const Index jcol, MatrixType& A, IndexVector& perm_r, Index& nseg, ScalarVector& dense, IndexVector& panel_lsub, IndexVector& segrep, IndexVector& repfnz, IndexVector& xprune, IndexVector& marker, IndexVector& parent, IndexVector& xplore, GlobalLU_t& glu)
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
MINRES.h 37 typedef typename Dest::Scalar Scalar;
38 typedef Matrix<Scalar,Dynamic,1> VectorType;
131 // typename _Preconditioner = IdentityPreconditioner<typename _MatrixType::Scalar> > // preconditioner must be positive definite
159 * and NumTraits<Scalar>::epsilon() for the tolerance.
206 typedef typename MatrixType::Scalar Scalar;
  /external/deqp/framework/randomshaders/
rsgExpression.cpp 178 if (valueRange.getMin().component(ndx).asScalar() != Scalar::min<int>() ||
179 valueRange.getMax().component(ndx).asScalar() != Scalar::max<int>())
198 if (valueRange.getMin().component(ndx).asScalar() != Scalar::min<float>() ||
199 valueRange.getMax().component(ndx).asScalar() != Scalar::max<float>())
232 valueRange.getMin().component(ndx) = Scalar::min<bool>();
233 valueRange.getMax().component(ndx) = Scalar::max<bool>();
240 valueRange.getMin().component(ndx) = Scalar::min<int>();
241 valueRange.getMax().component(ndx) = Scalar::max<int>();
248 valueRange.getMin().component(ndx) = Scalar::min<float>();
249 valueRange.getMax().component(ndx) = Scalar::max<float>()
    [all...]
  /external/deqp/modules/gles2/scripts/
gen-swizzles.py 16 # * not allowed for scalar types
164 inFloat = [Scalar(x) for x in [0.0, 1.0, 2.0, 3.5, -0.5, -20.125, 36.8125]]
165 inInt = [Scalar(x) for x in [0, 1, 2, 5, 8, 11, -12, -66, -192, 255]]
166 inBool = [Scalar(x) for x in [True, False]]
261 # * not allowed for scalar types
  /external/deqp/modules/gles3/scripts/
gen-swizzles.py 16 # * not allowed for scalar types
168 inFloat = [Scalar(x) for x in [0.0, 1.0, 2.0, 3.5, -0.5, -20.125, 36.8125]]
169 inInt = [Scalar(x) for x in [0, 1, 2, 5, 8, 11, -12, -66, -192, 255]]
170 inBool = [Scalar(x) for x in [True, False]]
265 # * not allowed for scalar types
  /external/eigen/Eigen/src/IterativeLinearSolvers/
IterativeSolverBase.h 26 typedef typename MatrixType::Scalar Scalar;
221 m_tolerance = NumTraits<Scalar>::epsilon();
  /external/eigen/Eigen/src/PaStiXSupport/
PaStiXSupport.h 36 typedef typename _MatrixType::Scalar Scalar;
45 typedef typename _MatrixType::Scalar Scalar;
54 typedef typename _MatrixType::Scalar Scalar;
125 typedef typename MatrixType::Scalar Scalar;
128 typedef Matrix<Scalar,Dynamic,1> Vector;
129 typedef SparseMatrix<Scalar, ColMajor> ColSpMatrix
    [all...]
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixLogarithm.h 35 typedef typename MatrixType::Scalar Scalar;
37 typedef typename NumTraits<Scalar>::Real RealScalar;
38 // typedef typename internal::stem_function<Scalar>::type StemFunction;
39 // typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
104 Scalar logA00 = log(A(0,0));
105 Scalar logA11 = log(A(1,1));
108 result(1,0) = Scalar(0);
118 Scalar y = A(1,1) - A(0,0), x = A(1,1) + A(0,0);
119 result(0,1) = A(0,1) * (Scalar(2) * numext::atanh2(y,x) + Scalar(0,2*M_PI*unwindingNumber)) / y
    [all...]
MatrixExponential.h 133 typedef typename internal::traits<MatrixType>::Scalar Scalar;
134 typedef typename NumTraits<Scalar>::Real RealScalar;
296 MatrixType A = m_M / pow(Scalar(2), m_squarings);
318 MatrixType A = m_M / pow(Scalar(2), m_squarings);
343 MatrixType A = m_M / pow(Scalar(2), m_squarings);
361 MatrixType A = m_M / pow(Scalar(2), m_squarings);
379 MatrixType A = m_M / pow(Scalar(2), m_squarings);
  /external/eigen/test/eigen2/
gsl_helper.h 24 template<typename Scalar, bool IsComplex = NumTraits<Scalar>::IsComplex> struct GslTraits
59 template<typename Scalar> struct GslTraits<Scalar,true>
150 res(i,j) = typename MatrixType::Scalar(
168 res[i] = typename VectorType::Scalar(
  /external/eigen/Eigen/src/Core/
ForceAlignedAccess.h 54 inline Scalar& coeffRef(Index row, Index col)
64 inline Scalar& coeffRef(Index index)
PermutationMatrix.h 69 typedef typename Traits::Scalar Scalar;
71 typedef Matrix<Scalar,RowsAtCompileTime,ColsAtCompileTime,0,MaxRowsAtCompileTime,MaxColsAtCompileTime>
122 other.coeffRef(indices().coeff(i),i) = typename DenseDerived::Scalar(1);
406 typedef typename IndicesType::Scalar Index;
468 typedef typename _IndicesType::Scalar Scalar;
469 typedef typename _IndicesType::Scalar Index;
634 typedef typename Traits::Scalar Scalar;
    [all...]
Assign_MKL.h 86 typedef typename Derived1::Scalar Scalar;
95 const Scalar *src_ptr = src.IsRowMajor ? &(src.nestedExpression().coeffRef(outer,0)) :
97 Scalar *dst_ptr = dst.IsRowMajor ? &(dst.coeffRef(outer,0)) : &(dst.coeffRef(0, outer));
  /external/eigen/Eigen/src/Eigen2Support/
Minor.h 74 inline Scalar& coeffRef(Index row, Index col)
79 inline const Scalar coeff(Index row, Index col) const
  /external/eigen/Eigen/src/OrderingMethods/
Ordering.h 63 SparseMatrix<typename MatrixType::Scalar, ColMajor, Index> symm;
75 SparseMatrix<typename SrcType::Scalar, ColMajor, Index> C; C = mat;
  /external/eigen/Eigen/src/QR/
ColPivHouseholderQR_MKL.h 52 typedef MatrixType::Scalar Scalar; \
  /external/eigen/Eigen/src/SVD/
JacobiSVD_MKL.h 48 typedef MatrixType::Scalar Scalar; \
52 /*const RealScalar precision = RealScalar(2) * NumTraits<Scalar>::epsilon();*/ \
  /external/lldb/include/lldb/Expression/
IRMemoryMap.h 57 void WriteScalarToMemory (lldb::addr_t process_address, Scalar &scalar, size_t size, Error &error);
60 void ReadScalarFromMemory (Scalar &scalar, lldb::addr_t process_address, size_t size, Error &error);
  /external/lldb/include/lldb/Target/
StackFrame.h 19 #include "lldb/Core/Scalar.h"
89 GetFrameBaseValue(Scalar &value, Error *error_ptr);
197 Scalar m_frame_base;
  /external/lldb/source/Plugins/Process/POSIX/
RegisterContext_i386.h 53 ReadRegisterValue(uint32_t reg, lldb_private::Scalar &value);
66 WriteRegisterValue(uint32_t reg, const lldb_private::Scalar &value);
  /external/eigen/bench/
quatmul.cpp 17 c = internal::quat_product<0, Quat, Quat, typename Quat::Scalar, Aligned>::run(a,b);
sparse_cholesky.cpp 41 // typedef SparseMatrix<Scalar,UpperTriangular> EigenSparseTriMatrix;
42 typedef SparseMatrix<Scalar,SelfAdjoint|LowerTriangular> EigenSparseSelfAdjointMatrix;
49 dst.fill(j,j) = internal::random<Scalar>(10,20);
52 Scalar v = (internal::random<float>(0,1) < density) ? internal::random<Scalar>() : 0;
  /external/eigen/lapack/
clacgv.f 23 * .. Scalar Arguments ..
82 * .. Scalar Arguments ..
cladiv.f 23 * .. Scalar Arguments ..
72 * .. Scalar Arguments ..

Completed in 123 milliseconds

<<11121314151617181920>>