Searched defs:coefficients (Results 1 - 25 of 31) sorted by relevance

12

/external/eigen/doc/special_examples/
H A DTutorial_sparse_example.cpp7 void buildProblem(std::vector<T>& coefficients, Eigen::VectorXd& b, int n);
18 std::vector<T> coefficients; // list of non-zeros coefficients local
20 buildProblem(coefficients, b, n);
23 A.setFromTriplets(coefficients.begin(), coefficients.end());
H A DTutorial_sparse_example_details.cpp19 void buildProblem(std::vector<T>& coefficients, Eigen::VectorXd& b, int n) argument
28 insertCoefficient(id, i-1,j, -1, coefficients, b, boundary);
29 insertCoefficient(id, i+1,j, -1, coefficients, b, boundary);
30 insertCoefficient(id, i,j-1, -1, coefficients, b, boundary);
31 insertCoefficient(id, i,j+1, -1, coefficients, b, boundary);
32 insertCoefficient(id, i,j, 4, coefficients, b, boundary);
/external/webrtc/webrtc/common_audio/signal_processing/
H A Dfilter_ar_fast_q12.c18 const int16_t* __restrict coefficients,
32 sum += coefficients[j] * data_out[i - j];
35 output = coefficients[0] * data_in[i];
16 WebRtcSpl_FilterARFastQ12(const int16_t* data_in, int16_t* data_out, const int16_t* __restrict coefficients, size_t coefficients_length, size_t data_length) argument
H A Ddownsample_fast.c19 const int16_t* __restrict coefficients,
38 out_s32 += coefficients[j] * data_in[i - j]; // Q12.
15 WebRtcSpl_DownsampleFastC(const int16_t* data_in, size_t data_in_length, int16_t* data_out, size_t data_out_length, const int16_t* __restrict coefficients, size_t coefficients_length, int factor, size_t delay) argument
H A Ddownsample_fast_mips.c18 const int16_t* __restrict coefficients,
32 int16_t* p_coefficients_0 = (int16_t*)&coefficients[0];
14 WebRtcSpl_DownsampleFast_mips(const int16_t* data_in, size_t data_in_length, int16_t* data_out, size_t data_out_length, const int16_t* __restrict coefficients, size_t coefficients_length, int factor, size_t delay) argument
H A Dfilter_ar_fast_q12_mips.c16 const int16_t* __restrict coefficients,
35 "lh %[coef0], 0(%[coefficients]) \n\t"
42 " addu %[coefptr], %[coefficients], %[offset] \n\t"
64 "addu %[coefptr], %[coefficients], %[offset] \n\t"
107 "addu %[coefptr], %[coefficients], %[offset] \n\t"
131 : [coefficients] "r" (coefficients), [data_length] "r" (data_length),
14 WebRtcSpl_FilterARFastQ12(const int16_t* data_in, int16_t* data_out, const int16_t* __restrict coefficients, size_t coefficients_length, size_t data_length) argument
H A Ddownsample_fast_neon.c21 const int16_t* __restrict coefficients,
50 int32x2_t coeff32 = vld1_dup_s32((int32_t*)&coefficients[j]);
72 int16x4_t coeff16x4 = vld1_dup_s16(&coefficients[j]);
91 int16x4_t coeff16x4 = vld1_dup_s16(&coefficients[j]);
118 int16x4_t coeff16x4 = vld1_s16(&coefficients[j]);
147 int16x4_t coeff16x4 = vld1_dup_s16(&coefficients[j]);
178 int16x4_t coeff16x4 = vld1_dup_s16(&coefficients[j]);
208 out_s32 = WebRtc_MulAccumW16(coefficients[j], data_in[i - j], out_s32);
17 WebRtcSpl_DownsampleFastNeon(const int16_t* data_in, size_t data_in_length, int16_t* data_out, size_t data_out_length, const int16_t* __restrict coefficients, size_t coefficients_length, int factor, size_t delay) argument
/external/pdfium/fxbarcode/common/reedsolomon/
H A DBC_ReedSolomon.cpp92 const auto& coefficients = remainder->GetCoefficients(); local
94 ecBytes > coefficients.size() ? ecBytes - coefficients.size() : 0;
97 for (size_t y = 0; y < coefficients.size(); y++)
98 (*toEncode)[dataBytes + numZeroCoefficients + y] = coefficients[y];
H A DBC_ReedSolomonGF256Poly.cpp33 int32_t coefficients) {
38 m_coefficients.push_back(coefficients);
46 const std::vector<int32_t>* coefficients) {
47 if (!coefficients || coefficients->empty())
51 size_t coefficientsLength = coefficients->size();
52 if (coefficientsLength > 1 && coefficients->front() == 0) {
55 (*coefficients)[firstNonZero] == 0) {
63 m_coefficients[j] = (*coefficients)[i];
66 m_coefficients = *coefficients;
32 CBC_ReedSolomonGF256Poly(CBC_ReedSolomonGF256* field, int32_t coefficients) argument
45 Init(CBC_ReedSolomonGF256* field, const std::vector<int32_t>* coefficients) argument
[all...]
/external/webrtc/webrtc/common_audio/
H A Dfir_filter_neon.cc21 FIRFilterNEON::FIRFilterNEON(const float* coefficients, argument
32 // Add zeros at the end of the coefficients.
35 // The coefficients are reversed to compensate for the order in which the
38 coefficients_[i + padding] = coefficients[coefficients_length - i - 1];
H A Dfir_filter_sse.cc21 FIRFilterSSE2::FIRFilterSSE2(const float* coefficients, argument
32 // Add zeros at the end of the coefficients.
35 // The coefficients are reversed to compensate for the order in which the
38 coefficients_[i + padding] = coefficients[coefficients_length - i - 1];
H A Dfir_filter.cc25 FIRFilterC(const float* coefficients,
37 FIRFilter* FIRFilter::Create(const float* coefficients, argument
40 if (!coefficients || coefficients_length <= 0 || max_input_length <= 0) {
50 new FIRFilterSSE2(coefficients, coefficients_length, max_input_length);
55 new FIRFilterSSE2(coefficients, coefficients_length, max_input_length);
57 filter = new FIRFilterC(coefficients, coefficients_length);
62 new FIRFilterNEON(coefficients, coefficients_length, max_input_length);
66 new FIRFilterNEON(coefficients, coefficients_length, max_input_length);
68 filter = new FIRFilterC(coefficients, coefficients_length);
71 filter = new FIRFilterC(coefficients, coefficients_lengt
77 FIRFilterC(const float* coefficients, size_t coefficients_length) argument
[all...]
/external/webrtc/webrtc/modules/audio_processing/transient/
H A Dwpd_node.cc24 const float* coefficients,
30 filter_(FIRFilter::Create(coefficients,
33 assert(length > 0 && coefficients && coefficients_length > 0);
23 WPDNode(size_t length, const float* coefficients, size_t coefficients_length) argument
/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/polynomials/
H A DPolynomialFunctionLagrangeForm.java41 * The coefficients of the polynomial, ordered by degree -- i.e.
42 * coefficients[0] is the constant term and coefficients[n] is the
45 private double coefficients[]; field in class:PolynomialFunctionLagrangeForm
58 * Whether the polynomial coefficients are available.
128 * Returns a copy of the coefficients array.
132 * Note that coefficients computation can be ill-conditioned. Use with caution
135 * @return a fresh copy of the coefficients array
141 double[] out = new double[coefficients.length];
142 System.arraycopy(coefficients,
[all...]
H A DPolynomialFunctionNewtonForm.java40 * The coefficients of the polynomial, ordered by degree -- i.e.
41 * coefficients[0] is the constant term and coefficients[n] is the
44 private double coefficients[]; field in class:PolynomialFunctionNewtonForm
52 * When all c[i] = 0, a[] becomes normal polynomial coefficients,
53 * i.e. a[i] = coefficients[i].
58 * Whether the polynomial coefficients are available.
69 * @param a the coefficients in Newton form formula
106 * Returns a copy of coefficients in Newton form formula.
110 * @return a fresh copy of coefficients i
[all...]
H A DPolynomialFunction.java29 * Immutable representation of a real polynomial function with real coefficients.
44 * The coefficients of the polynomial, ordered by degree -- i.e.,
45 * coefficients[0] is the constant term and coefficients[n] is the
48 private final double coefficients[]; field in class:PolynomialFunction
51 * Construct a polynomial with the given coefficients. The first element
52 * of the coefficients array is the constant term. Higher degree
53 * coefficients follow in sequence. The degree of the resulting polynomial
58 * the coefficients property.</p>
60 * @param c polynomial coefficients
124 evaluate(double[] coefficients, double argument) argument
233 differentiate(double[] coefficients) argument
[all...]
H A DPolynomialsUtils.java187 /** Get the coefficients array for a given degree.
189 * @param coefficients list where the computed coefficients are stored
190 * @param generator recurrence coefficients generator
191 * @return coefficients array
194 final ArrayList<BigFraction> coefficients,
197 final int maxDegree = (int) FastMath.floor(FastMath.sqrt(2 * coefficients.size())) - 1;
200 computeUpToDegree(degree, maxDegree, generator, coefficients);
205 // coefficients for polynomial 1 are l [1] ... l [2] (degrees 0 ... 1)
206 // coefficients fo
193 buildPolynomial(final int degree, final ArrayList<BigFraction> coefficients, final RecurrenceCoefficientsGenerator generator) argument
230 computeUpToDegree(final int degree, final int maxDegree, final RecurrenceCoefficientsGenerator generator, final ArrayList<BigFraction> coefficients) argument
[all...]
/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/solvers/
H A DLaguerreSolver.java231 double coefficients[] = ((PolynomialFunction) f).getCoefficients();
232 Complex c[] = new Complex[coefficients.length];
233 for (int i = 0; i < coefficients.length; i++) {
234 c[i] = new Complex(coefficients[i], 0.0);
273 * Find all complex roots for the polynomial with the given coefficients,
276 * @param coefficients the polynomial coefficients array
286 public Complex[] solveAll(double coefficients[], double initial) throws argument
289 Complex c[] = new Complex[coefficients.length];
292 c[i] = new Complex(coefficients[
311 solveAll(Complex coefficients[], Complex initial) argument
361 solve(Complex coefficients[], Complex initial) argument
[all...]
/external/webrtc/webrtc/modules/audio_processing/vad/
H A Dpole_zero_filter.cc57 const float* coefficients) {
61 sum += coefficients[k] * past[past_index];
56 FilterArPast(const T* past, size_t order, const float* coefficients) argument
/external/apache-commons-math/src/main/java/org/apache/commons/math/optimization/linear/
H A DLinearConstraint.java45 * The c<sub>i</sub>, l<sub>i</sub> or r<sub>i</sub> are the coefficients of the constraints, the x<sub>i</sub>
57 private final transient RealVector coefficients; field in class:LinearConstraint
75 * @param coefficients The coefficients of the constraint (left hand side)
79 public LinearConstraint(final double[] coefficients, final Relationship relationship, argument
81 this(new ArrayRealVector(coefficients), relationship, value);
94 * @param coefficients The coefficients of the constraint (left hand side)
98 public LinearConstraint(final RealVector coefficients, final Relationship relationship, argument
100 this.coefficients
[all...]
H A DLinearObjectiveFunction.java36 * The c<sub>i</sub> and d are the coefficients of the equation,
48 private final transient RealVector coefficients; field in class:LinearObjectiveFunction
54 * @param coefficients The coefficients for the linear equation being optimized
57 public LinearObjectiveFunction(double[] coefficients, double constantTerm) { argument
58 this(new ArrayRealVector(coefficients), constantTerm);
62 * @param coefficients The coefficients for the linear equation being optimized
65 public LinearObjectiveFunction(RealVector coefficients, double constantTerm) { argument
66 this.coefficients
[all...]
H A DSimplexTableau.java185 // decision variable coefficients
268 * Get the -1 times the sum of all coefficients in the given array.
269 * @param coefficients coefficients to sum
270 * @return the -1 times the sum of all coefficients in the given array.
272 protected static double getInvertedCoeffiecientSum(final RealVector coefficients) { argument
274 for (double coefficient : coefficients.getData()) {
374 double[] coefficients = new double[getOriginalNumDecisionVariables()];
375 for (int i = 0; i < coefficients.length; i++) {
378 coefficients[
[all...]
/external/libxcam/modules/ocl/
H A Dcv_edgetaper.cpp34 CVEdgetaper::create_weights (const cv::Mat &image, const cv::Mat &psf, cv::Mat &coefficients) argument
65 coefficients = weights.clone ();
76 cv::Mat coefficients; local
77 create_weights (img, psf, coefficients);
80 result = result.mul (coefficients) + blurred.mul (cv::Scalar (1.0f) - coefficients);
/external/skia/src/gpu/gl/
H A DGrGLPathRendering.cpp217 float coefficients[3 * 3]; local
220 coefficients[0] = SkScalarToFloat(matrix[SkMatrix::kMScaleX]);
221 coefficients[1] = SkScalarToFloat(matrix[SkMatrix::kMSkewX]);
222 coefficients[2] = SkScalarToFloat(matrix[SkMatrix::kMTransX]);
225 coefficients[3] = SkScalarToFloat(matrix[SkMatrix::kMSkewY]);
226 coefficients[4] = SkScalarToFloat(matrix[SkMatrix::kMScaleY]);
227 coefficients[5] = SkScalarToFloat(matrix[SkMatrix::kMTransY]);
231 coefficients[6] = SkScalarToFloat(matrix[SkMatrix::kMPersp0]);
232 coefficients[7] = SkScalarToFloat(matrix[SkMatrix::kMPersp1]);
233 coefficients[
[all...]
/external/skqp/src/gpu/gl/
H A DGrGLPathRendering.cpp217 float coefficients[3 * 3]; local
220 coefficients[0] = SkScalarToFloat(matrix[SkMatrix::kMScaleX]);
221 coefficients[1] = SkScalarToFloat(matrix[SkMatrix::kMSkewX]);
222 coefficients[2] = SkScalarToFloat(matrix[SkMatrix::kMTransX]);
225 coefficients[3] = SkScalarToFloat(matrix[SkMatrix::kMSkewY]);
226 coefficients[4] = SkScalarToFloat(matrix[SkMatrix::kMScaleY]);
227 coefficients[5] = SkScalarToFloat(matrix[SkMatrix::kMTransY]);
231 coefficients[6] = SkScalarToFloat(matrix[SkMatrix::kMPersp0]);
232 coefficients[7] = SkScalarToFloat(matrix[SkMatrix::kMPersp1]);
233 coefficients[
[all...]

Completed in 508 milliseconds

12