/external/ceres-solver/include/ceres/ |
D | loss_function.h | 314 ScaledLoss(const LossFunction* rho, double a, Ownership ownership) : in ScaledLoss() 368 LossFunctionWrapper(LossFunction* rho, Ownership ownership) in LossFunctionWrapper() 383 void Reset(LossFunction* rho, Ownership ownership) { in Reset()
|
/external/libcxx/test/std/numerics/complex.number/complex.value.ops/ |
D | polar.pass.cpp | 23 test(const T& rho, std::complex<T> x) in test() 30 test(const T& rho, const T& theta, std::complex<T> x) in test()
|
/external/apache-commons-math/src/main/java/org/apache/commons/math/optimization/direct/ |
D | NelderMead.java | 36 private final double rho; field in NelderMead 64 public NelderMead(final double rho, final double khi, in NelderMead()
|
/external/ceres-solver/internal/ceres/ |
D | loss_function_test.cc | 51 double rho[3]; in AssertLossFunctionIsValid() local 122 double rho[3]; in TEST() local 200 double rho[3]; in TEST() local
|
D | corrector_test.cc | 148 double rho[3]; in TEST() local 216 double rho[3]; in TEST() local
|
D | conjugate_gradients_solver.cc | 111 double rho = 1.0; in Solve() local
|
D | residual_block.cc | 163 double rho[3]; in Evaluate() local
|
/external/opencv3/modules/cudaimgproc/src/ |
D | hough_segments.cpp | 77 …HoughSegmentDetectorImpl(float rho, float theta, int minLineLength, int maxLineGap, int maxLines) : in HoughSegmentDetectorImpl() 84 void setRho(float rho) { rho_ = rho; } in setRho() 181 Ptr<HoughSegmentDetector> cv::cuda::createHoughSegmentDetector(float rho, float theta, int minLineL… in createHoughSegmentDetector()
|
D | hough_lines.cpp | 73 HoughLinesDetectorImpl(float rho, float theta, int threshold, bool doSort, int maxLines) : in HoughLinesDetectorImpl() 81 void setRho(float rho) { rho_ = rho; } in setRho() 206 Ptr<HoughLinesDetector> cv::cuda::createHoughLinesDetector(float rho, float theta, int threshold, b… in createHoughLinesDetector()
|
/external/eigen/unsupported/Eigen/src/IterativeSolvers/ |
D | ConstrainedConjGrad.h | 58 Scalar rho, rho_1, alpha; in pseudo_inverse() local 114 Scalar rho = 1.0, rho_1, lambda, gamma; in constrained_cg() local
|
/external/opencv3/modules/cudaimgproc/src/cuda/ |
D | hough_lines.cu | 129 …void linesAccum_gpu(const unsigned int* list, int count, PtrStepSzi accum, float rho, float theta,… in linesAccum_gpu() 149 …(const PtrStepSzi accum, float2* out, int* votes, const int maxSize, const float rho, const float … in linesGetResult() 177 …int linesGetResult_gpu(PtrStepSzi accum, float2* out, int* votes, int maxSize, float rho, float th… in linesGetResult_gpu()
|
D | hough_segments.cu | 58 const float rho, const float theta, in houghLinesProbabilistic() 217 …bilistic_gpu(PtrStepSzb mask, PtrStepSzi accum, int4* out, int maxSize, float rho, float theta, in… in houghLinesProbabilistic_gpu()
|
/external/opencv3/modules/imgproc/src/ |
D | hough.cpp | 53 float rho; member 79 HoughLinesStandard( const Mat& img, float rho, float theta, in HoughLinesStandard() 193 float rho, theta; member 199 float rho, float theta, int threshold, in HoughLinesSDiv() 416 float rho, float theta, int threshold, in HoughLinesProbabilistic() 689 static bool ocl_fillAccum(InputArray _pointsList, OutputArray _accum, int total_points, double rho,… in ocl_fillAccum() 730 static bool ocl_HoughLines(InputArray _src, OutputArray _lines, double rho, double theta, int thres… in ocl_HoughLines() 790 static bool ocl_HoughLinesP(InputArray _src, OutputArray _lines, double rho, double theta, int thre… in ocl_HoughLinesP() 850 double rho, double theta, int threshold, in HoughLines() 869 double rho, double theta, int threshold, in HoughLinesP() [all …]
|
/external/iproute2/netem/ |
D | stats.c | 24 double mu=0.0, sigma=0.0, sumsquare=0.0, sum=0.0, top=0.0, rho=0.0; in stats() local
|
D | maketable.c | 51 arraystats(double *x, int limit, double *mu, double *sigma, double *rho) in arraystats() 200 double mu, sigma, rho; in main() local
|
/external/mesa3d/src/mesa/drivers/dri/i965/ |
D | brw_lower_texture_gradients.cpp | 128 ir_rvalue *rho; in visit_leave() local
|
/external/opencv3/samples/python2/ |
D | houghlines.py | 31 rho = lines[i][0][0] variable
|
/external/opencv3/modules/cudaimgproc/test/ |
D | test_hough.cpp | 70 float rho = lines[i][0], theta = lines[i][1]; in PARAM_TEST_CASE() local 90 const float rho = 1.0f; in CUDA_TEST_P() local
|
/external/opencv3/modules/cudaimgproc/perf/ |
D | perf_hough.cpp | 90 const float rho = 1.0f; in PERF_TEST_P() local 139 const float rho = 1.0f; variable
|
/external/bouncycastle/bcprov/src/main/java/org/bouncycastle/math/ec/ |
D | WTauNafMultiplier.java | 37 ZTauElement rho = Tnaf.partModReduction(k, m, a, s, mu, (byte)10); in multiplyPositive() local
|
/external/eigen/Eigen/src/IterativeLinearSolvers/ |
D | BiCGSTAB.h | 52 Scalar rho = 1; in bicgstab() local
|
/external/eigen/bench/ |
D | eig33.cpp | 76 Scalar rho = internal::sqrt(-a_over_3); in computeRoots() local
|
/external/opencv3/modules/cudaoptflow/src/cuda/ |
D | tvl1flow.cu | 108 …epf u1, const PtrStepf u2, PtrStepf I1w, PtrStepf I1wx, PtrStepf I1wy, PtrStepf grad, PtrStepf rho) in warpBackwardKernel() 170 PtrStepSzf I1wy, PtrStepSzf grad, PtrStepSzf rho, in warpBackward() 236 … const float rho = rho_c(y, x) + (I1wxVal * u1OldVal + I1wyVal * u2OldVal + gamma * u3OldVal); in estimateUKernel() local
|
/external/opencv3/3rdparty/openexr/Imath/ |
D | ImathMatrixAlgo.cpp | 355 const T rho = mu_1 / mu_2; in twoSidedJacobiRotation() local 496 const T rho = mu_1 / mu_2; in twoSidedJacobiRotation() local 995 const T rho = mu1 / mu2; in jacobiRotation() local 1050 const T rho = mu1 / mu2; in jacobiRotation() local
|
/external/opencv/cv/src/ |
D | _cvlist.h | 367 float rho, theta; member
|