HomeSort by relevance Sort by last modified time
    Searched defs:diag (Results 226 - 250 of 285) sorted by null

1 2 3 4 5 6 7 8 91011>>

  /prebuilts/clang/host/linux-x86/clang-4479392/include/clang/Basic/
DiagnosticIDs.h 27 namespace diag { namespace in namespace:clang
50 #define DIAG(ENUM,FLAGS,DEFAULT_MAPPING,DESC,GROUP,\
55 #undef DIAG
90 static DiagnosticMapping Make(diag::Severity Severity, bool IsUser,
102 diag::Severity getSeverity() const { return (diag::Severity)Severity; }
103 void setSeverity(diag::Severity Value) { Severity = (unsigned)Value; }
109 return getSeverity() == diag::Severity::Error ||
110 getSeverity() == diag::Severity::Fatal;
155 diag::CustomDiagInfo *CustomDiagInfo
    [all...]
  /prebuilts/ndk/r16/sources/third_party/shaderc/third_party/spirv-tools/source/val/
validation_state.cpp 246 DiagnosticStream ValidationState_t::diag(spv_result_t error_code) const { function in class:libspirv::ValidationState_t
  /external/eigen/unsupported/Eigen/src/NonLinearOptimization/
HybridNonLinearSolver.h 91 FVectorType fvec, qtf, diag; member in class:Eigen::HybridNonLinearSolver
136 diag.setConstant(n, 1.);
152 diag.resize(n);
153 eigen_assert( (!useExternalScaling || diag.size()==n) && "When useExternalScaling is set, the caller must provide a valid 'diag'");
164 if (diag[j] <= 0.)
209 diag[j] = (wa2[j]==0.) ? 1. : wa2[j];
213 xnorm = diag.cwiseProduct(x).stableNorm();
233 diag = diag.cwiseMax(wa2)
    [all...]
LevenbergMarquardt.h 107 FVectorType fvec, qtf, diag; member in class:Eigen::LevenbergMarquardt
181 diag.resize(n);
182 eigen_assert( (!useExternalScaling || diag.size()==n) && "When useExternalScaling is set, the caller must provide a valid 'diag'");
195 if (diag[j] <= 0.)
241 diag[j] = (wa2[j]==0.)? 1. : wa2[j];
245 xnorm = diag.cwiseProduct(x).stableNorm();
270 diag = diag.cwiseMax(wa2);
275 internal::lmpar2<Scalar>(qrfac, diag, qtf, delta, par, wa1)
    [all...]
  /external/lmfit/lib/
lmmin.c 31 const double* diag, const double* qtb, const double delta,
36 const double* diag, const double* qtb, double* x,
207 double* diag = (double*)pws; local
224 /* Initialize diag. */
227 diag[j] = 1;
341 /** Initialize or update diag and delta. **/
344 /* diag := norms of the columns of the initial Jacobian */
346 diag[j] = wa2[j] ? wa2[j] : 1;
349 wa3[j] = diag[j] * x[j];
352 fprintf(msgfile, "lmmin diag ");
    [all...]
  /prebuilts/clang/host/darwin-x86/clang-4579689/include/clang/Basic/
DiagnosticIDs.h 28 namespace diag { namespace in namespace:clang
68 #define DIAG(ENUM,FLAGS,DEFAULT_MAPPING,DESC,GROUP,\
73 #undef DIAG
108 static DiagnosticMapping Make(diag::Severity Severity, bool IsUser,
120 diag::Severity getSeverity() const { return (diag::Severity)Severity; }
121 void setSeverity(diag::Severity Value) { Severity = (unsigned)Value; }
127 return getSeverity() == diag::Severity::Error ||
128 getSeverity() == diag::Severity::Fatal;
173 diag::CustomDiagInfo *CustomDiagInfo
    [all...]
  /prebuilts/clang/host/darwin-x86/clang-4630689/include/clang/Basic/
DiagnosticIDs.h 28 namespace diag { namespace in namespace:clang
68 #define DIAG(ENUM,FLAGS,DEFAULT_MAPPING,DESC,GROUP,\
73 #undef DIAG
108 static DiagnosticMapping Make(diag::Severity Severity, bool IsUser,
120 diag::Severity getSeverity() const { return (diag::Severity)Severity; }
121 void setSeverity(diag::Severity Value) { Severity = (unsigned)Value; }
127 return getSeverity() == diag::Severity::Error ||
128 getSeverity() == diag::Severity::Fatal;
173 diag::CustomDiagInfo *CustomDiagInfo
    [all...]
  /prebuilts/clang/host/darwin-x86/clang-4639204/include/clang/Basic/
DiagnosticIDs.h 28 namespace diag { namespace in namespace:clang
68 #define DIAG(ENUM,FLAGS,DEFAULT_MAPPING,DESC,GROUP,\
73 #undef DIAG
108 static DiagnosticMapping Make(diag::Severity Severity, bool IsUser,
120 diag::Severity getSeverity() const { return (diag::Severity)Severity; }
121 void setSeverity(diag::Severity Value) { Severity = (unsigned)Value; }
127 return getSeverity() == diag::Severity::Error ||
128 getSeverity() == diag::Severity::Fatal;
173 diag::CustomDiagInfo *CustomDiagInfo
    [all...]
  /prebuilts/clang/host/darwin-x86/clang-4691093/include/clang/Basic/
DiagnosticIDs.h 28 namespace diag { namespace in namespace:clang
68 #define DIAG(ENUM,FLAGS,DEFAULT_MAPPING,DESC,GROUP,\
73 #undef DIAG
108 static DiagnosticMapping Make(diag::Severity Severity, bool IsUser,
120 diag::Severity getSeverity() const { return (diag::Severity)Severity; }
121 void setSeverity(diag::Severity Value) { Severity = (unsigned)Value; }
127 return getSeverity() == diag::Severity::Error ||
128 getSeverity() == diag::Severity::Fatal;
173 diag::CustomDiagInfo *CustomDiagInfo
    [all...]
  /prebuilts/clang/host/linux-x86/clang-4579689/include/clang/Basic/
DiagnosticIDs.h 28 namespace diag { namespace in namespace:clang
68 #define DIAG(ENUM,FLAGS,DEFAULT_MAPPING,DESC,GROUP,\
73 #undef DIAG
108 static DiagnosticMapping Make(diag::Severity Severity, bool IsUser,
120 diag::Severity getSeverity() const { return (diag::Severity)Severity; }
121 void setSeverity(diag::Severity Value) { Severity = (unsigned)Value; }
127 return getSeverity() == diag::Severity::Error ||
128 getSeverity() == diag::Severity::Fatal;
173 diag::CustomDiagInfo *CustomDiagInfo
    [all...]
  /prebuilts/clang/host/linux-x86/clang-4630689/include/clang/Basic/
DiagnosticIDs.h 28 namespace diag { namespace in namespace:clang
68 #define DIAG(ENUM,FLAGS,DEFAULT_MAPPING,DESC,GROUP,\
73 #undef DIAG
108 static DiagnosticMapping Make(diag::Severity Severity, bool IsUser,
120 diag::Severity getSeverity() const { return (diag::Severity)Severity; }
121 void setSeverity(diag::Severity Value) { Severity = (unsigned)Value; }
127 return getSeverity() == diag::Severity::Error ||
128 getSeverity() == diag::Severity::Fatal;
173 diag::CustomDiagInfo *CustomDiagInfo
    [all...]
  /prebuilts/clang/host/linux-x86/clang-4639204/include/clang/Basic/
DiagnosticIDs.h 28 namespace diag { namespace in namespace:clang
68 #define DIAG(ENUM,FLAGS,DEFAULT_MAPPING,DESC,GROUP,\
73 #undef DIAG
108 static DiagnosticMapping Make(diag::Severity Severity, bool IsUser,
120 diag::Severity getSeverity() const { return (diag::Severity)Severity; }
121 void setSeverity(diag::Severity Value) { Severity = (unsigned)Value; }
127 return getSeverity() == diag::Severity::Error ||
128 getSeverity() == diag::Severity::Fatal;
173 diag::CustomDiagInfo *CustomDiagInfo
    [all...]
  /prebuilts/clang/host/linux-x86/clang-4691093/include/clang/Basic/
DiagnosticIDs.h 28 namespace diag { namespace in namespace:clang
68 #define DIAG(ENUM,FLAGS,DEFAULT_MAPPING,DESC,GROUP,\
73 #undef DIAG
108 static DiagnosticMapping Make(diag::Severity Severity, bool IsUser,
120 diag::Severity getSeverity() const { return (diag::Severity)Severity; }
121 void setSeverity(diag::Severity Value) { Severity = (unsigned)Value; }
127 return getSeverity() == diag::Severity::Error ||
128 getSeverity() == diag::Severity::Fatal;
173 diag::CustomDiagInfo *CustomDiagInfo
    [all...]
  /external/apache-commons-math/src/main/java/org/apache/commons/math/estimation/
LevenbergMarquardtEstimator.java 176 * This bound is set to the product of initialStepBoundFactor and the euclidean norm of diag*x if nonzero,
264 double[] diag = new double[cols]; local
305 diag[k] = dk;
337 diag[j] = FastMath.max(diag[j], jacNorm[j]);
354 determineLMParameter(oldRes, delta, diag, work1, work2, work3);
362 double s = diag[pj] * lmDir[pj];
427 double xK = diag[k] * parameters[k].getEstimate();
492 * @param diag diagonal matrix
497 private void determineLMParameter(double[] qy, double delta, double[] diag,
    [all...]
  /external/apache-commons-math/src/main/java/org/apache/commons/math/optimization/general/
LevenbergMarquardtOptimizer.java 185 * norm of diag*x if nonzero, or else to initialStepBoundFactor itself. In most
257 double[] diag = new double[cols]; local
305 diag[k] = dk;
338 diag[j] = FastMath.max(diag[j], jacNorm[j]);
358 determineLMParameter(qtf, delta, diag, work1, work2, work3);
366 double s = diag[pj] * lmDir[pj];
428 double xK = diag[k] * point[k];
499 * @param diag diagonal matrix
504 private void determineLMParameter(double[] qy, double delta, double[] diag,
    [all...]
  /external/eigen/Eigen/src/Eigenvalues/
SelfAdjointEigenSolver.h 24 ComputationInfo computeFromTridiagonal_impl(DiagType& diag, SubDiagType& subdiag, const Index maxIterations, bool computeEigenvectors, MatrixType& eivec);
229 * \param[in] diag The vector containing the diagonal of the matrix.
238 SelfAdjointEigenSolver& computeFromTridiagonal(const RealVectorType& diag, const SubDiagonalType& subdiag , int options=ComputeEigenvectors);
376 * pair of two vectors \a diag and \a subdiag.
378 * \param diag the diagonal part of the input selfadjoint tridiagonal matrix
393 static void tridiagonal_qr_step(RealScalar* diag, RealScalar* subdiag, Index start, Index end, Scalar* matrixQ, Index n);
428 RealVectorType& diag = m_eivalues; local
437 internal::tridiagonalization_inplace(mat, diag, m_subdiag, computeEigenvectors);
439 m_info = internal::computeFromTridiagonal_impl(diag, m_subdiag, m_maxIterations, computeEigenvectors, m_eivec);
451 ::computeFromTridiagonal(const RealVectorType& diag, const SubDiagonalType& subdiag , int options
    [all...]
  /external/eigen/Eigen/src/SVD/
BDCSVD.h 177 void computeSingVals(const ArrayRef& col0, const ArrayRef& diag, const IndicesRef& perm, VectorType& singVals, ArrayRef shifts, ArrayRef mus);
178 void perturbCol0(const ArrayRef& col0, const ArrayRef& diag, const IndicesRef& perm, const VectorType& singVals, const ArrayRef& shifts, const ArrayRef& mus, ArrayRef zhat);
179 void computeSingVecs(const ArrayRef& zhat, const ArrayRef& diag, const IndicesRef& perm, const VectorType& singVals, const ArrayRef& shifts, const ArrayRef& mus, MatrixXr& U, MatrixXr& V);
186 static RealScalar secularEq(RealScalar x, const ArrayRef& col0, const ArrayRef& diag, const IndicesRef &perm, const ArrayRef& diagShifted, RealScalar shift);
577 ArrayRef diag = m_workspace.head(n); local
578 diag(0) = Literal(0);
586 if (col0.hasNaN() || diag.hasNaN())
594 while(actual_n>1 && diag(actual_n-1)==Literal(0)) --actual_n;
608 std::cout << " d: " << diag.transpose() << "\n";
612 computeSingVals(col0, diag, perm, singVals, shifts, mus)
    [all...]
  /external/eigen/unsupported/Eigen/src/LevenbergMarquardt/
LevenbergMarquardt.h 97 void lmpar2(const QRSolver &qr, const VectorType &diag, const VectorType &qtb,
175 /** Use an external Scaling. If set to true, pass a nonzero diagonal to diag() */
197 FVectorType& diag() {return m_diag; } function in class:Eigen::LevenbergMarquardt
  /external/jdiff/src/jdiff/
DiffMyers.java 109 private int diag (int xoff, int xlim, int yoff, int ylim) method in class:DiffMyers
309 int d = diag (xoff, xlim, yoff, ylim);
318 and that case was handled above without calling `diag'.
  /external/libvpx/libvpx/vp8/encoder/
mcomp.c 235 unsigned int left, right, up, down, diag; local
297 * with the last iteration could be 2 ( if diag selected)
309 case 0: CHECK_BETTER(diag, tr - 2, tc - 2); break;
310 case 1: CHECK_BETTER(diag, tr - 2, tc + 2); break;
311 case 2: CHECK_BETTER(diag, tr + 2, tc - 2); break;
312 case 3: CHECK_BETTER(diag, tr + 2, tc + 2); break;
323 * with the last iteration could be 2 ( if diag selected)
336 case 0: CHECK_BETTER(diag, tr - 1, tc - 1); break;
337 case 1: CHECK_BETTER(diag, tr - 1, tc + 1); break;
338 case 2: CHECK_BETTER(diag, tr + 1, tc - 1); break
377 int left, right, up, down, diag; local
673 int left, right, up, down, diag; local
    [all...]
  /external/opencv/ml/src/
mlem.cpp 798 CvMat whdr, iwhdr, diag, *w, *iw; local
821 cvTranspose( cvGetDiag(*covs, &diag), inv_eigen_values );
875 cvTranspose( cvGetDiag( covs[k], &diag ), w );
    [all...]
  /external/python/cpython2/RISCOS/Modules/
drawfmodule.c 157 drawfile_diagram *diag; local
176 diag=realloc(self->drawf,self->size+size);
177 if(!diag) return PyErr_NoMemory();
178 self->drawf=diag;
179 dobj=(drawfile_object*)((char*)diag+self->size);
232 diag=realloc(self->drawf,self->size);
233 if(!diag) return PyErr_NoMemory();
234 self->drawf=diag;
237 extend(&(diag->bbox),box);
247 drawfile_diagram *diag; local
286 drawfile_diagram *diag; local
331 drawfile_diagram *diag; local
365 drawfile_diagram *diag; local
    [all...]
  /external/v8/tools/clang/blink_gc_plugin/
DiagnosticsReporter.cpp 306 unsigned diag = diag_fields_require_tracing_; local
309 diag = diag_fields_improperly_traced_;
313 ReportDiagnostic(trace->getLocStart(), diag)
  /frameworks/base/tools/aapt2/compile/
PngCrunch.cpp 68 IDiagnostics* diag = (IDiagnostics*)png_get_error_ptr(png_ptr); local
69 diag->Warn(DiagMessage() << warning_msg);
74 IDiagnostics* diag = (IDiagnostics*)png_get_error_ptr(png_ptr); local
75 diag->Error(DiagMessage() << error_msg);
  /frameworks/native/libs/math/include/math/
TMatHelpers.h 287 // diag. this handles matrices of matrices
289 CONSTEXPR typename MATRIX::col_type PURE diag(const MATRIX& m) { function in namespace:android::details::matrix
290 static_assert(MATRIX::NUM_COLS == MATRIX::NUM_ROWS, "diag only defined for square matrices");

Completed in 547 milliseconds

1 2 3 4 5 6 7 8 91011>>