Searched refs:degree (Results 1 - 25 of 51) sorted by relevance

123

/external/chromium-trace/trace-viewer/tracing/third_party/gl-matrix/src/gl-matrix/
H A Dcommon.js41 var degree = Math.PI / 180; variable
49 return a * degree;
/external/eigen/unsupported/Eigen/src/Splines/
H A DSplineFitting.h31 * where \f$p\f$ is the degree and \f$m+1\f$ the number knots
35 * \param[in] degree The spline degree which is used during the interpolation.
41 void KnotAveraging(const KnotVectorType& parameters, DenseIndex degree, KnotVectorType& knots) argument
43 knots.resize(parameters.size()+degree+1);
45 for (DenseIndex j=1; j<parameters.size()-degree; ++j)
46 knots(j+degree) = parameters.segment(j,degree).mean();
48 knots.segment(0,degree+1) = KnotVectorType::Zero(degree
116 Interpolate(const PointArrayType& pts, DenseIndex degree, const KnotVectorType& knot_parameters) argument
148 Interpolate(const PointArrayType& pts, DenseIndex degree) argument
[all...]
H A DSpline.h31 * degree for optimization purposes (would result in stack allocation
40 enum { Degree = _Degree /*!< The spline curve's degree. */ };
56 * For Splines with dynamic degree, the resulting degree will be 0.
137 * spline degree.
177 * \brief Returns the spline degree.
179 DenseIndex degree() const;
190 static DenseIndex Span(typename SplineTraits<Spline>::Scalar u, DenseIndex degree, const typename SplineTraits<Spline>::KnotVectorType& knots);
201 * \param degree The degree o
213 Span( typename SplineTraits< Spline<_Scalar, _Dim, _Degree> >::Scalar u, DenseIndex degree, const typename SplineTraits< Spline<_Scalar, _Dim, _Degree> >::KnotVectorType& knots) argument
226 BasisFunctions( typename Spline<_Scalar, _Dim, _Degree>::Scalar u, DenseIndex degree, const typename Spline<_Scalar, _Dim, _Degree>::KnotVectorType& knots) argument
261 DenseIndex Spline<_Scalar, _Dim, _Degree>::degree() const function in class:Eigen::Spline
[all...]
/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/polynomials/
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...]
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 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
/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/Eigen/src/MatrixFunctions/
H A DMatrixLogarithm.h57 void computePade(MatrixType& result, const MatrixType& T, int degree);
131 int degree; local
142 degree = getPadeDegree(normTminusI);
144 if ((degree - degree2 <= 1) || (numberOfExtraSquareRoots == 1))
153 computePade(result, T, degree);
157 /* \brief Get suitable degree for Pade approximation. (specialized for RealScalar = float) */
161 const float maxNormForPade[] = { 2.5111573934555054e-1 /* degree = 3 */ , 4.0535837411880493e-1,
163 int degree = 3; local
164 for (; degree <= maxPadeDegree; ++degree)
176 int degree = 3; local
207 int degree = 3; local
216 computePade(MatrixType& result, const MatrixType& T, int degree) argument
235 const int degree = 3; local
251 const int degree = 4; local
267 const int degree = 5; local
285 const int degree = 6; local
303 const int degree = 7; local
323 const int degree = 8; local
343 const int degree = 9; local
365 const int degree = 10; local
387 const int degree = 11; local
[all...]
H A DMatrixPower.h57 void computePade(int degree, const MatrixType& IminusT, MatrixType& res) const;
95 void MatrixPowerAtomic<MatrixType>::computePade(int degree, const MatrixType& IminusT, MatrixType& res) const argument
97 int i = degree<<1;
98 res = (m_p-degree) / ((i-1)<<1) * IminusT;
138 int degree, degree2, numberOfSquareRoots = 0; local
161 degree = getPadeDegree(normIminusT);
163 if (degree - degree2 <= 1 || hasExtraSquareRoot)
171 computePade(degree, IminusT, res);
183 const float maxNormForPade[] = { 2.8064004e-1f /* degree = 3 */ , 4.3386528e-1f };
184 int degree local
196 int degree = 3; local
228 int degree = 3; local
[all...]
/external/ceres-solver/internal/ceres/
H A Dpolynomial.cc57 const int degree = companion_matrix.rows(); local
71 for (int i = 0; i < degree; ++i) {
107 const int degree = polynomial.size() - 1; local
109 companion_matrix.resize(degree, degree);
112 companion_matrix.col(degree - 1) = -polynomial.reverse().head(degree);
191 const int degree = polynomial.size() - 1; local
199 if (degree == 0) {
209 if (degree
254 const int degree = polynomial.rows() - 1; local
344 const int degree = num_constraints - 1; local
[all...]
/external/freetype/include/internal/services/
H A Dsvkern.h34 FT_Int degree,
/external/pdfium/third_party/freetype/include/internal/services/
H A Dsvkern.h34 FT_Int degree,
/external/pdfium/third_party/freetype/src/type1/
H A Dt1afm.h46 FT_Int degree,
H A Dt1afm.c361 FT_Int degree,
376 if ( tk->degree != degree )
/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/eigen/Eigen/src/OrderingMethods/
H A DAmd.h86 * Approximate minimum degree ordering algorithm.
115 Index* degree = W + 5*(n+1); local
130 head[i] = -1; // degree list i is empty
137 degree[i] = len[i]; // degree of node i
144 /* --- Initialize degree lists ------------------------------------------ */
147 d = degree[i];
166 next[i] = head[d]; /* put node i in degree list d */
173 /* --- Select node of minimum approximate degree -------------------- */
176 head[mindeg] = next[k]; /* remove k from degree lis
[all...]
H A DEigen_Colamd.h159 /* a degree list */
160 Index hash ; /* hash value, if col is not in a degree list */
161 Index prev ; /* previous column in degree list, if col is in a */
162 /* degree list (but not at the head of a degree list) */
166 Index degree_next ; /* next column, if col is in a degree list */
179 Index degree ; /* number of principal & non-principal columns in row */ member in union:internal::Colamd_Row::__anon4321
312 * \brief Computes a column ordering using the column approximate minimum degree ordering
343 Index max_deg ; /* maximum row degree */
651 Row [row].shared1.degree
[all...]
/external/kernel-headers/original/uapi/drm/
H A Dexynos_drm.h168 * @degree: flag of degree information.
185 __u32 degree; member in struct:drm_exynos_ipp_prop_list
203 * @degree: property of rotation degree.
211 enum drm_exynos_degree degree; member in struct:drm_exynos_ipp_config
/external/apache-commons-math/src/main/java/org/apache/commons/math/ode/nonstiff/
H A DGraggBulirschStoerStepInterpolator.java164 // copy the interpolation polynoms (up to the current degree only)
182 * interpolation polynoms up to the given degree
183 * @param maxDegree maximal degree to handle
235 * @param mu degree of the interpolation polynomial
386 final int degree = in.readInt();
387 resetTables(degree);
388 currentDegree = degree;
/external/opencv/ml/src/
H A Dmlsvm.cpp170 svm_type(CvSVM::C_SVC), kernel_type(CvSVM::RBF), degree(0),
182 degree(_degree), gamma(_gamma), coef0(_coef0),
262 cvPow( &R, &R, params->degree );
1231 params.degree = 0;
1232 else if( params.degree <= 0 )
1233 CV_ERROR( CV_StsOutOfRange, "The kernel parameter <degree> must be positive" );
1613 double gamma = 0, C = 0, degree = 0, coef = 0, p = 0, nu = 0; local
1676 degree_grid.min_val = degree_grid.max_val = params.degree;
1684 degree_grid.min_val = degree_grid.max_val = params.degree;
1775 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/freetype/include/internal/
H A Dt1types.h150 FT_Int degree; member in struct:AFM_TrackKernRec_
/external/jmonkeyengine/engine/src/desktop/jme3tools/navigation/
H A DPosition.java26 private double degree; field in class:Position
43 * @param degree
46 // public Position(double dblLat, double dblLng, double degree) throws InvalidPositionException {
49 // this.degree = degree;
152 * Returns the degree of the entity
153 * @return degree
157 // return degree;
/external/pdfium/third_party/freetype/include/internal/
H A Dt1types.h150 FT_Int degree; member in struct:AFM_TrackKernRec_
/external/robolectric/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;

Completed in 1107 milliseconds

123