Searched defs:degree (Results 1 - 25 of 43) sorted by relevance

12

/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/interpolation/
H A DSmoothingPolynomialBicubicSplineInterpolator.java45 * Default constructor. The degree of the fitting polynomials is set to 3.
52 * @param degree Degree of the polynomial fitting functions.
54 public SmoothingPolynomialBicubicSplineInterpolator(int degree) { argument
55 this(degree, degree);
/external/pdfium/fxbarcode/common/reedsolomon/
H A DBC_ReedSolomon.cpp43 size_t degree) {
44 if (degree >= m_cachedGenerators.size()) {
46 for (size_t d = m_cachedGenerators.size(); d <= degree; ++d) {
60 return m_cachedGenerators[degree].get();
42 BuildGenerator( size_t degree) argument
H A DBC_ReedSolomonGF256.cpp78 int32_t degree,
81 if (degree < 0) {
91 std::vector<int32_t> coefficients(degree + 1);
77 BuildMonomial( int32_t degree, int32_t coefficient, int32_t& e) argument
H A DBC_ReedSolomonGF256Poly.cpp83 int32_t CBC_ReedSolomonGF256Poly::GetCoefficients(int32_t degree) const {
84 return m_coefficients[m_coefficients.size() - 1 - degree];
183 CBC_ReedSolomonGF256Poly::MultiplyByMonomial(int32_t degree, argument
185 if (degree < 0)
191 std::vector<int32_t> product(size + degree);
/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.
43 * coefficient of x^n where n is the degree of the polynomial.
93 * Returns the degree of the polynomial.
95 * @return the degree of the polynomial
97 public int degree() { method in class:PolynomialFunctionLagrangeForm
223 final int n = degree() + 1;
261 // polynomial of degree n-1. tc[] are the coefficients of the i-th
H A DPolynomialFunctionNewtonForm.java40 * The coefficients of the polynomial, ordered by degree -- i.e.
42 * coefficient of x^n where n is the degree of the polynomial.
97 * Returns the degree of the polynomial.
99 * @return the degree of the polynomial
101 public int degree() { method in class:PolynomialFunctionNewtonForm
178 final int n = degree();
H A DPolynomialFunction.java44 * The coefficients of the polynomial, ordered by degree -- i.e.,
46 * coefficient of x^n where n is the degree of the polynomial.
52 * of the coefficients array is the constant term. Higher degree
53 * coefficients follow in sequence. The degree of the resulting polynomial
94 * Returns the degree of the polynomial
96 * @return the degree of the polynomial
98 public int degree() { method in class:PolynomialFunction
143 // identify the lowest degree polynomial
169 // identify the lowest degree polynomial
H A DPolynomialsUtils.java92 * @param degree degree of the polynomial
93 * @return Chebyshev polynomial of specified degree
95 public static PolynomialFunction createChebyshevPolynomial(final int degree) { argument
96 return buildPolynomial(degree, CHEBYSHEV_COEFFICIENTS,
117 * @param degree degree of the polynomial
118 * @return Hermite polynomial of specified degree
120 public static PolynomialFunction createHermitePolynomial(final int degree) { argument
121 return buildPolynomial(degree, HERMITE_COEFFICIENT
146 createLaguerrePolynomial(final int degree) argument
173 createLegendrePolynomial(final int degree) argument
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/optimization/fitting/
H A DPolynomialFitter.java38 /** Polynomial degree. */
39 private final int degree; field in class:PolynomialFitter
43 * ie. a n-degree polynomial has n+1 coefficients.</p>
44 * @param degree maximal degree of the polynomial
47 public PolynomialFitter(int degree, final DifferentiableMultivariateVectorialOptimizer optimizer) { argument
49 this.degree = degree;
76 return new PolynomialFunction(fitter.fit(new ParametricPolynomial(), new double[degree + 1]));
/external/eigen/unsupported/test/
H A Dsplines.cpp244 const unsigned int degree = 3; local
258 points, derivatives, derivativeIndices, degree);
/external/eigen/Eigen/src/OrderingMethods/
H A DAmd.h86 * Approximate minimum degree ordering algorithm.
118 StorageIndex* degree = W + 5*(n+1); local
133 head[i] = -1; // degree list i is empty
140 degree[i] = len[i]; // degree of node i
144 /* --- Initialize degree lists ------------------------------------------ */
155 d = degree[i];
174 next[i] = head[d]; /* put node i in degree list d */
185 /* --- Select node of minimum approximate degree -------------------- */
188 head[mindeg] = next[k]; /* remove k from degree lis
[all...]
H A DEigen_Colamd.h152 /* a degree list */
153 IndexType hash ; /* hash value, if col is not in a degree list */
154 IndexType prev ; /* previous column in degree list, if col is in a */
155 /* degree list (but not at the head of a degree list) */
159 IndexType degree_next ; /* next column, if col is in a degree list */
172 IndexType degree ; /* number of principal & non-principal columns in row */ member in union:internal::Colamd_Row::__anon6325
305 * \brief Computes a column ordering using the column approximate minimum degree ordering
336 IndexType max_deg ; /* maximum row degree */
644 Row [row].shared1.degree
[all...]
/external/antlr/antlr-3.4/runtime/C/src/
H A Dantlr3bitset.c485 ANTLR3_UINT32 degree; local
494 degree = 0;
503 degree++;
508 return degree;
/external/dng_sdk/source/
H A Ddng_misc_opcodes.cpp435 uint32 degree,
443 , fDegree (degree)
462 // Reduce degree if possible.
434 dng_opcode_MapPolynomial(const dng_area_spec &areaSpec, uint32 degree, const real64 *coefficient) argument
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixLogarithm.h70 /* \brief Get suitable degree for Pade approximation. (specialized for RealScalar = float) */
73 const float maxNormForPade[] = { 2.5111573934555054e-1 /* degree = 3 */ , 4.0535837411880493e-1,
77 int degree = minPadeDegree; local
78 for (; degree <= maxPadeDegree; ++degree)
79 if (normTminusI <= maxNormForPade[degree - minPadeDegree])
81 return degree;
84 /* \brief Get suitable degree for Pade approximation. (specialized for RealScalar = double) */
87 const double maxNormForPade[] = { 1.6206284795015624e-2 /* degree = 3 */ , 5.3873532631381171e-2,
91 int degree local
123 int degree = minPadeDegree; local
132 matrix_log_compute_pade(MatrixType& result, const MatrixType& T, int degree) argument
232 int degree; local
[all...]
H A DMatrixPower.h103 void computePade(int degree, const MatrixType& IminusT, ResultType& res) const;
162 void MatrixPowerAtomic<MatrixType>::computePade(int degree, const MatrixType& IminusT, ResultType& res) const argument
164 int i = 2*degree;
165 res = (m_p-degree) / (2*i-2) * IminusT;
206 int degree, degree2, numberOfSquareRoots = 0; local
216 degree = getPadeDegree(normIminusT);
218 if (degree - degree2 <= 1 || hasExtraSquareRoot)
226 computePade(degree, IminusT, res);
238 const float maxNormForPade[] = { 2.8064004e-1f /* degree = 3 */ , 4.3386528e-1f };
239 int degree local
251 int degree = 3; local
283 int degree = 3; local
[all...]
/external/eigen/unsupported/Eigen/src/Splines/
H A DSpline.h31 * degree for optimization purposes (would result in stack allocation
40 enum { Degree = _Degree /*!< The spline curve's degree. */ };
62 * For Splines with dynamic degree, the resulting degree will be 0.
143 * spline degree.
183 * \brief Returns the spline degree.
185 DenseIndex degree() const;
196 static DenseIndex Span(typename SplineTraits<Spline>::Scalar u, DenseIndex degree, const typename SplineTraits<Spline>::KnotVectorType& knots);
207 * \param degree The degree o
234 Span( typename SplineTraits< Spline<_Scalar, _Dim, _Degree> >::Scalar u, DenseIndex degree, const typename SplineTraits< Spline<_Scalar, _Dim, _Degree> >::KnotVectorType& knots) argument
247 BasisFunctions( typename Spline<_Scalar, _Dim, _Degree>::Scalar u, DenseIndex degree, const typename Spline<_Scalar, _Dim, _Degree>::KnotVectorType& knots) argument
282 DenseIndex Spline<_Scalar, _Dim, _Degree>::degree() const function in class:Eigen::Spline
500 BasisFunctionDerivatives( const typename Spline<_Scalar, _Dim, _Degree>::Scalar u, const DenseIndex order, const DenseIndex degree, const typename Spline<_Scalar, _Dim, _Degree>::KnotVectorType& knots) argument
[all...]
H A DSplineFitting.h35 * where \f$p\f$ is the degree and \f$m+1\f$ the number knots
39 * \param[in] degree The spline degree which is used during the interpolation.
45 void KnotAveraging(const KnotVectorType& parameters, DenseIndex degree, KnotVectorType& knots) argument
47 knots.resize(parameters.size()+degree+1);
49 for (DenseIndex j=1; j<parameters.size()-degree; ++j)
50 knots(j+degree) = parameters.segment(j,degree).mean();
52 knots.segment(0,degree+1) = KnotVectorType::Zero(degree
78 KnotAveragingWithDerivatives(const ParameterVectorType& parameters, const unsigned int degree, const IndexArray& derivativeIndices, KnotVectorType& knots) argument
290 Interpolate(const PointArrayType& pts, DenseIndex degree, const KnotVectorType& knot_parameters) argument
322 Interpolate(const PointArrayType& pts, DenseIndex degree) argument
332 InterpolateWithDerivatives(const PointArrayType& points, const PointArrayType& derivatives, const IndexArray& derivativeIndices, const unsigned int degree, const ParameterVectorType& parameters) argument
419 InterpolateWithDerivatives(const PointArrayType& points, const PointArrayType& derivatives, const IndexArray& derivativeIndices, const unsigned int degree) argument
[all...]
/external/robolectric/v1/src/main/java/com/xtremelabs/robolectric/shadows/
H A DShadowMapView.java137 private int scaleDegree(int degree, int minPixel, int maxPixel, int centerDegree, int spanDegrees) { argument
139 int offsetDegrees = degree - minDegree;
/external/freetype/include/freetype/internal/
H A Dt1types.h152 FT_Int degree; member in struct:AFM_TrackKernRec_
/external/swiftshader/third_party/LLVM/include/llvm/CodeGen/PBQP/
H A DGraph.h59 unsigned degree; member in class:PBQP::Graph::NodeEntry
62 NodeEntry(const Vector &costs) : costs(costs), degree(0) {}
65 unsigned getDegree() const { return degree; }
69 ++degree;
73 --degree;
240 /// \brief Get a node's degree.
242 /// @return The degree of the node.
/external/bouncycastle/bcprov/src/main/java/org/bouncycastle/math/ec/
H A DLongArray.java442 public int degree() method in class:LongArray
861 * Find out the degree of each argument and handle the zero cases
863 int aDeg = degree();
868 int bDeg = other.degree();
993 * Find out the degree of each argument and handle the zero cases
995 int aDeg = degree();
1000 int bDeg = other.degree();
1125 * Find out the degree of each argument and handle the zero cases
1127 int aDeg = degree();
1132 int bDeg = other.degree();
[all...]
/external/kernel-headers/original/uapi/drm/
H A Dexynos_drm.h186 * @degree: flag of degree information.
203 __u32 degree; member in struct:drm_exynos_ipp_prop_list
221 * @degree: property of rotation degree.
229 __u32 degree; member in struct:drm_exynos_ipp_config
/external/ImageMagick/MagickCore/
H A Dstatistic.c2266 % (coefficient and degree pairs).
2280 % o terms: the list of polynomial coefficients and degree pairs and a
2413 degree;
2424 degree=(MagickRealType) terms[(j << 1)+1];
2426 pow(QuantumScale*GetPixelChannel(image,channel,p),degree);
2401 degree; local
/external/mesa3d/src/gallium/drivers/nouveau/codegen/
H A Dnv50_ir_ra.cpp747 uint32_t degree; member in class:nv50_ir::GCRA::RIG_Node
833 nodes[i].degree, nodes[i].degreeLimit);
883 degree = 0;
1134 this->degree += relDegree[node->colors][colors];
1135 node->degree += relDegree[colors][node->colors];
1258 if (nodes[i].degree < nodes[i].degreeLimit) {
1274 bool move = b->degree >= b->degreeLimit;
1278 a->getValue()->id, a->degree, a->degreeLimit,
1279 b->getValue()->id, b->degree, b->degreeLimit);
1281 b->degree
[all...]

Completed in 647 milliseconds

12