/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/polynomials/ |
D | PolynomialFunction.java | 48 private final double coefficients[]; field in PolynomialFunction 73 this.coefficients = new double[n]; in PolynomialFunction() 74 System.arraycopy(c, 0, this.coefficients, 0, n); in PolynomialFunction() 89 return evaluate(coefficients, x); in value() 99 return coefficients.length - 1; in degree() 111 return coefficients.clone(); in getCoefficients() 124 protected static double evaluate(double[] coefficients, double argument) { in evaluate() argument 125 int n = coefficients.length; in evaluate() 129 double result = coefficients[n - 1]; in evaluate() 131 result = argument * result + coefficients[j]; in evaluate() [all …]
|
D | PolynomialFunctionNewtonForm.java | 44 private double coefficients[]; field in PolynomialFunctionNewtonForm 142 double[] out = new double[coefficients.length]; in getCoefficients() 143 System.arraycopy(coefficients, 0, out, 0, coefficients.length); in getCoefficients() 180 coefficients = new double[n+1]; in computeCoefficients() 182 coefficients[i] = 0.0; in computeCoefficients() 185 coefficients[0] = a[n]; in computeCoefficients() 188 coefficients[j] = coefficients[j-1] - c[i] * coefficients[j]; in computeCoefficients() 190 coefficients[0] = a[i] - c[i] * coefficients[0]; in computeCoefficients()
|
D | PolynomialsUtils.java | 194 final ArrayList<BigFraction> coefficients, 197 final int maxDegree = (int) FastMath.floor(FastMath.sqrt(2 * coefficients.size())) - 1; 200 computeUpToDegree(degree, maxDegree, generator, coefficients); 216 a[i] = coefficients.get(start + i).doubleValue(); 232 final ArrayList<BigFraction> coefficients) { 244 BigFraction ck = coefficients.get(startK); 245 BigFraction ckm1 = coefficients.get(startKm1); 248 coefficients.add(ck.multiply(ai[0]).subtract(ckm1.multiply(ai[2]))); 253 ck = coefficients.get(startK + i); 254 ckm1 = coefficients.get(startKm1 + i); [all …]
|
D | PolynomialFunctionLagrangeForm.java | 45 private double coefficients[]; field in PolynomialFunctionLagrangeForm 141 double[] out = new double[coefficients.length]; in getCoefficients() 142 System.arraycopy(coefficients, 0, out, 0, coefficients.length); in getCoefficients() 224 coefficients = new double[n]; in computeCoefficients() 226 coefficients[i] = 0.0; in computeCoefficients() 264 coefficients[n-1] += t * tc[n-1]; in computeCoefficients() 267 coefficients[j] += t * tc[j]; in computeCoefficients()
|
/external/kotlinx.coroutines/benchmarks/src/jmh/kotlin/benchmarks/ |
D | ForkJoinBenchmark.kt | 46 lateinit var coefficients: LongArray variable in benchmarks.ForkJoinBenchmark 52 coefficients = LongArray(TASK_SIZE) { ThreadLocalRandom.current().nextLong(0, 1024 * 1024) } in setup() 57 …ForkJoinPool.commonPool().asCoroutineDispatcher()).startAsync(coefficients, 0, coefficients.size).… in <lambda>() 62 startAsync(coefficients, 0, coefficients.size).await() in <lambda>() 67 val task = RecursiveAction(coefficients, 0, coefficients.size) in fjpRecursiveTask() 73 val task = Task(coefficients, 0, coefficients.size) in fjpTask() 77 …suspend fun CoroutineScope.startAsync(coefficients: LongArray, start: Int, end: Int): Deferred<Dou… in <lambda>() 79 compute(coefficients, start, end) in <lambda>() 81 val first = startAsync(coefficients, start, start + (end - start) / 2) in <lambda>() 82 val second = startAsync(coefficients, start + (end - start) / 2, end) in <lambda>() [all …]
|
/external/tensorflow/tensorflow/python/keras/optimizer_v2/ |
D | rmsprop.py | 146 coefficients = ((apply_state or {}).get((var_device, var_dtype)) 159 coefficients["lr_t"], 160 coefficients["rho"], 161 coefficients["momentum"], 162 coefficients["epsilon"], 170 coefficients["lr_t"], 171 coefficients["rho"], 172 coefficients["momentum"], 173 coefficients["epsilon"], 177 rms_t = (coefficients["rho"] * rms + [all …]
|
D | ftrl.py | 163 coefficients = ((apply_state or {}).get((var_device, var_dtype)) 175 coefficients['lr_t'], 176 coefficients['l1_regularization_strength'], 177 coefficients['l2_regularization_strength'], 178 coefficients['learning_rate_power'], 186 coefficients['lr_t'], 187 coefficients['l1_regularization_strength'], 188 coefficients['l2_regularization_strength'], 189 coefficients['l2_shrinkage_regularization_strength'], 190 coefficients['learning_rate_power'], [all …]
|
D | adam.py | 194 coefficients = ((apply_state or {}).get((var_device, var_dtype)) 205 coefficients['beta_1_power'], 206 coefficients['beta_2_power'], 207 coefficients['lr_t'], 208 coefficients['beta_1_t'], 209 coefficients['beta_2_t'], 210 coefficients['epsilon'], 220 coefficients['beta_1_power'], 221 coefficients['beta_2_power'], 222 coefficients['lr_t'], [all …]
|
D | nadam.py | 168 coefficients = ((apply_state or {}).get((var_device, var_dtype)) 174 g_prime = grad / coefficients['one_minus_m_schedule_new'] 175 m_t = (coefficients['beta_1_t'] * m + 176 coefficients['one_minus_beta_1_t'] * grad) 178 m_t_prime = m_t / coefficients['one_minus_m_schedule_next'] 179 v_t = (coefficients['beta_2_t'] * v + 180 coefficients['one_minus_beta_2_t'] * math_ops.square(grad)) 182 v_t_prime = v_t / coefficients['v_t_prime_denominator'] 183 m_t_bar = (coefficients['one_minus_m_t'] * g_prime + 184 coefficients['m_t_1'] * m_t_prime) [all …]
|
D | adamax.py | 136 coefficients = ((apply_state or {}).get((var_device, var_dtype)) 146 coefficients['beta_1_power'], 147 coefficients['lr_t'], 148 coefficients['beta_1_t'], 149 coefficients['beta_2_t'], 150 coefficients['epsilon'], 156 coefficients = ((apply_state or {}).get((var_device, var_dtype)) 161 m_slice = array_ops.gather(m, indices, axis=coefficients['zero']) 162 m_t_slice = (m_slice * coefficients['beta_1_t'] + 163 grad * coefficients['one_minus_beta_1_t']) [all …]
|
D | gradient_descent.py | 110 coefficients = ((apply_state or {}).get((var_device, var_dtype)) 118 coefficients["lr_t"], 120 coefficients["momentum"], 125 var.handle, coefficients["lr_t"], grad, use_locking=self._use_locking) 134 coefficients = (kwargs.get("apply_state", {}).get((var_device, var_dtype)) 138 var.handle, indices, -grad * coefficients["lr_t"]) 143 coefficients = ((apply_state or {}).get((var_device, var_dtype)) 150 coefficients["lr_t"], 153 coefficients["momentum"],
|
D | adadelta.py | 129 coefficients = ((apply_state or {}).get((var_device, var_dtype)) 138 coefficients['lr_t'], 139 coefficients['rho'], 140 coefficients['epsilon'], 146 coefficients = ((apply_state or {}).get((var_device, var_dtype)) 155 coefficients['lr_t'], 156 coefficients['rho'], 157 coefficients['epsilon'],
|
/external/apache-commons-math/src/main/java/org/apache/commons/math/optimization/linear/ |
D | LinearObjectiveFunction.java | 48 private final transient RealVector coefficients; field in LinearObjectiveFunction 57 public LinearObjectiveFunction(double[] coefficients, double constantTerm) { in LinearObjectiveFunction() argument 58 this(new ArrayRealVector(coefficients), constantTerm); in LinearObjectiveFunction() 65 public LinearObjectiveFunction(RealVector coefficients, double constantTerm) { in LinearObjectiveFunction() argument 66 this.coefficients = coefficients; in LinearObjectiveFunction() 75 return coefficients; in getCoefficients() 92 return coefficients.dotProduct(point) + constantTerm; in getValue() 101 return coefficients.dotProduct(point) + constantTerm; in getValue() 114 return (constantTerm == rhs.constantTerm) && coefficients.equals(rhs.coefficients); in equals() 123 return Double.valueOf(constantTerm).hashCode() ^ coefficients.hashCode(); in hashCode() [all …]
|
D | LinearConstraint.java | 57 private final transient RealVector coefficients; field in LinearConstraint 79 public LinearConstraint(final double[] coefficients, final Relationship relationship, in LinearConstraint() argument 81 this(new ArrayRealVector(coefficients), relationship, value); in LinearConstraint() 98 public LinearConstraint(final RealVector coefficients, final Relationship relationship, in LinearConstraint() argument 100 this.coefficients = coefficients; in LinearConstraint() 131 this.coefficients = new ArrayRealVector(sub, false); in LinearConstraint() 158 this.coefficients = lhsCoefficients.subtract(rhsCoefficients); in LinearConstraint() 168 return coefficients; in getCoefficients() 199 coefficients.equals(rhs.coefficients); in equals() 209 coefficients.hashCode(); in hashCode() [all …]
|
/external/webrtc/webrtc/common_audio/signal_processing/ |
D | filter_ar_fast_q12_armv7.S | 26 @ r2: &coefficients[0] 34 @ r10: coefficients[j] 36 @ r12: &coefficients[j] 51 sub r12, #4 @ &coefficients[coefficients_length - 2] 63 ldr r10, [r12], #-4 @ coefficients[j - 1], coefficients[j] 65 smlatt r8, r10, r5, r8 @ sum2 += coefficients[j] * data_out[i - j + 1]; 66 smlatb r7, r10, r5, r7 @ sum1 += coefficients[j] * data_out[i - j]; 67 smlabt r7, r10, r5, r7 @ coefficients[j - 1] * data_out[i - j + 1]; 69 smlabb r8, r10, r5, r8 @ coefficients[j - 1] * data_out[i - j + 2]; 74 ldrsh r10, [r12, #2] @ Filter coefficients coefficients[2] [all …]
|
/external/webrtc/webrtc/common_audio/ |
D | fir_filter.cc | 25 FIRFilterC(const float* coefficients, 37 FIRFilter* FIRFilter::Create(const float* coefficients, in Create() argument 40 if (!coefficients || coefficients_length <= 0 || max_input_length <= 0) { in Create() 50 new FIRFilterSSE2(coefficients, coefficients_length, max_input_length); in Create() 55 new FIRFilterSSE2(coefficients, coefficients_length, max_input_length); in Create() 57 filter = new FIRFilterC(coefficients, coefficients_length); in Create() 62 new FIRFilterNEON(coefficients, coefficients_length, max_input_length); in Create() 66 new FIRFilterNEON(coefficients, coefficients_length, max_input_length); in Create() 68 filter = new FIRFilterC(coefficients, coefficients_length); in Create() 71 filter = new FIRFilterC(coefficients, coefficients_length); in Create() [all …]
|
/external/pdfium/fxbarcode/common/reedsolomon/ |
D | BC_ReedSolomonGF256Poly.cpp | 35 const std::vector<int32_t>& coefficients) in CBC_ReedSolomonGF256Poly() argument 38 ASSERT(!coefficients.empty()); in CBC_ReedSolomonGF256Poly() 39 if (coefficients.size() == 1 || coefficients.front() != 0) { in CBC_ReedSolomonGF256Poly() 40 m_coefficients = coefficients; in CBC_ReedSolomonGF256Poly() 45 while (firstNonZero < coefficients.size() && in CBC_ReedSolomonGF256Poly() 46 coefficients[firstNonZero] == 0) { in CBC_ReedSolomonGF256Poly() 49 if (firstNonZero == coefficients.size()) { in CBC_ReedSolomonGF256Poly() 52 m_coefficients.resize(coefficients.size() - firstNonZero); in CBC_ReedSolomonGF256Poly() 53 for (size_t i = firstNonZero, j = 0; i < coefficients.size(); i++, j++) in CBC_ReedSolomonGF256Poly() 54 m_coefficients[j] = coefficients[i]; in CBC_ReedSolomonGF256Poly()
|
D | BC_ReedSolomon.cpp | 84 const auto& coefficients = remainder->GetCoefficients(); in Encode() local 86 ecBytes > coefficients.size() ? ecBytes - coefficients.size() : 0; in Encode() 89 for (size_t y = 0; y < coefficients.size(); y++) in Encode() 90 (*toEncode)[dataBytes + numZeroCoefficients + y] = coefficients[y]; in Encode()
|
/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/solvers/ |
D | LaguerreSolver.java | 231 double coefficients[] = ((PolynomialFunction) f).getCoefficients(); in solve() local 232 Complex c[] = new Complex[coefficients.length]; in solve() 233 for (int i = 0; i < coefficients.length; i++) { in solve() 234 c[i] = new Complex(coefficients[i], 0.0); in solve() 286 public Complex[] solveAll(double coefficients[], double initial) throws in solveAll() argument 289 Complex c[] = new Complex[coefficients.length]; in solveAll() 292 c[i] = new Complex(coefficients[i], 0.0); in solveAll() 311 public Complex[] solveAll(Complex coefficients[], Complex initial) throws in solveAll() argument 314 int n = coefficients.length - 1; in solveAll() 322 c[i] = coefficients[i]; in solveAll() [all …]
|
/external/eigen/doc/special_examples/ |
D | Tutorial_sparse_example.cpp | 7 void buildProblem(std::vector<T>& coefficients, Eigen::VectorXd& b, int n); 18 std::vector<T> coefficients; // list of non-zeros coefficients in main() local 20 buildProblem(coefficients, b, n); in main() 23 A.setFromTriplets(coefficients.begin(), coefficients.end()); in main()
|
D | Tutorial_sparse_example_details.cpp | 19 void buildProblem(std::vector<T>& coefficients, Eigen::VectorXd& b, int n) in buildProblem() argument 28 insertCoefficient(id, i-1,j, -1, coefficients, b, boundary); in buildProblem() 29 insertCoefficient(id, i+1,j, -1, coefficients, b, boundary); in buildProblem() 30 insertCoefficient(id, i,j-1, -1, coefficients, b, boundary); in buildProblem() 31 insertCoefficient(id, i,j+1, -1, coefficients, b, boundary); in buildProblem() 32 insertCoefficient(id, i,j, 4, coefficients, b, boundary); in buildProblem()
|
/external/skqp/src/gpu/gl/ |
D | GrGLPathRendering.cpp | 149 float coefficients[3 * 3]; in setProgramPathFragmentInputTransform() local 152 coefficients[0] = SkScalarToFloat(matrix[SkMatrix::kMScaleX]); in setProgramPathFragmentInputTransform() 153 coefficients[1] = SkScalarToFloat(matrix[SkMatrix::kMSkewX]); in setProgramPathFragmentInputTransform() 154 coefficients[2] = SkScalarToFloat(matrix[SkMatrix::kMTransX]); in setProgramPathFragmentInputTransform() 157 coefficients[3] = SkScalarToFloat(matrix[SkMatrix::kMSkewY]); in setProgramPathFragmentInputTransform() 158 coefficients[4] = SkScalarToFloat(matrix[SkMatrix::kMScaleY]); in setProgramPathFragmentInputTransform() 159 coefficients[5] = SkScalarToFloat(matrix[SkMatrix::kMTransY]); in setProgramPathFragmentInputTransform() 163 coefficients[6] = SkScalarToFloat(matrix[SkMatrix::kMPersp0]); in setProgramPathFragmentInputTransform() 164 coefficients[7] = SkScalarToFloat(matrix[SkMatrix::kMPersp1]); in setProgramPathFragmentInputTransform() 165 coefficients[8] = SkScalarToFloat(matrix[SkMatrix::kMPersp2]); in setProgramPathFragmentInputTransform() [all …]
|
/external/skia/src/gpu/gl/ |
D | GrGLPathRendering.cpp | 145 float coefficients[3 * 3]; in setProgramPathFragmentInputTransform() local 148 coefficients[0] = SkScalarToFloat(matrix[SkMatrix::kMScaleX]); in setProgramPathFragmentInputTransform() 149 coefficients[1] = SkScalarToFloat(matrix[SkMatrix::kMSkewX]); in setProgramPathFragmentInputTransform() 150 coefficients[2] = SkScalarToFloat(matrix[SkMatrix::kMTransX]); in setProgramPathFragmentInputTransform() 153 coefficients[3] = SkScalarToFloat(matrix[SkMatrix::kMSkewY]); in setProgramPathFragmentInputTransform() 154 coefficients[4] = SkScalarToFloat(matrix[SkMatrix::kMScaleY]); in setProgramPathFragmentInputTransform() 155 coefficients[5] = SkScalarToFloat(matrix[SkMatrix::kMTransY]); in setProgramPathFragmentInputTransform() 159 coefficients[6] = SkScalarToFloat(matrix[SkMatrix::kMPersp0]); in setProgramPathFragmentInputTransform() 160 coefficients[7] = SkScalarToFloat(matrix[SkMatrix::kMPersp1]); in setProgramPathFragmentInputTransform() 161 coefficients[8] = SkScalarToFloat(matrix[SkMatrix::kMPersp2]); in setProgramPathFragmentInputTransform() [all …]
|
/external/tensorflow/tensorflow/lite/experimental/microfrontend/lib/ |
D | window_util.c | 37 state->coefficients = malloc(state->size * sizeof(*state->coefficients)); in WindowPopulateState() 38 if (state->coefficients == NULL) { in WindowPopulateState() 49 state->coefficients[i] = in WindowPopulateState() 70 free(state->coefficients); in WindowFreeStateContents()
|
/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/interpolation/ |
D | SplineInterpolator.java | 115 double coefficients[] = new double[4]; in interpolate() local 117 coefficients[0] = y[i]; in interpolate() 118 coefficients[1] = b[i]; in interpolate() 119 coefficients[2] = c[i]; in interpolate() 120 coefficients[3] = d[i]; in interpolate() 121 polynomials[i] = new PolynomialFunction(coefficients); in interpolate()
|