Searched refs:normal (Results 1 - 25 of 221) sorted by relevance

123456789

/external/mesa3d/src/gallium/state_trackers/d3d1x/progs/d3d11gears/
H A Dd3d11gears.hlsl40 float3 normal : NORMAL;
46 float3 normal : NORMAL;
59 result.normal = mul((float3x3)modelview, input.normal);
67 float3 nnormal = normalize(input.normal);
/external/eigen/Eigen/src/Geometry/
H A DHyperplane.h30 * \f$ n \cdot x + d = 0 \f$ where \f$ n \f$ is a unit normal vector of the plane (linear part)
64 /** Construct a plane from its normal \a n and a point \a e onto the plane.
65 * \warning the vector normal is assumed to be normalized.
70 normal() = n;
74 /** Constructs a plane from its normal \a n and distance to the origin \a d
76 * \warning the vector normal is assumed to be normalized.
81 normal() = n;
91 result.normal() = (p1 - p0).unitOrthogonal();
92 result.offset() = -p0.dot(result.normal());
104 result.normal()
157 EIGEN_DEVICE_FUNC inline ConstNormalReturnType normal() const { return ConstNormalReturnType(m_coeffs,0,0,dim(),1); } function in class:Eigen::Hyperplane
162 EIGEN_DEVICE_FUNC inline NormalReturnType normal() { return NormalReturnType(m_coeffs,0,0,dim(),1); } function in class:Eigen::Hyperplane
[all...]
/external/vulkan-validation-layers/libs/glm/gtx/
H A Dhanded_coordinate_space.hpp59 detail::tvec3<T, P> const & normal);
67 detail::tvec3<T, P> const & normal);
/external/clang/test/SemaCXX/
H A Dwarn-unused-attribute.cpp15 TestNormal normal; local
/external/mesa3d/src/mesa/tnl/
H A Dt_vb_normals.c43 GLvector4f normal; member in struct:normal_stage_data
59 /* We can only use the display list's saved normal lengths if we've
71 &store->normal ); /* resulting normals */
74 store->normal.stride = 4 * sizeof(GLfloat);
77 store->normal.stride = 0;
80 VB->AttribPtr[_TNL_ATTRIB_NORMAL] = &store->normal;
89 * to point to the appropriate normal transformation routine.
128 * transform normal vectors (just leave them in object coordinates)
159 _mesa_vector4f_alloc( &store->normal, 0, tnl->vb.Size, 32 );
172 _mesa_vector4f_free( &store->normal );
[all...]
H A Dt_vb_texgen.c101 const GLvector4f *normal,
107 const GLfloat *norm = normal->start;
110 for (i=0;i<count;i++,STRIDE_F(coord,stride),STRIDE_F(norm,normal->stride)) {
128 const GLvector4f *normal,
135 GLfloat *norm = normal->start;
138 for (i=0;i<count;i++,STRIDE_F(coord,stride),STRIDE_F(norm,normal->stride)) {
158 const GLvector4f *normal,
177 const GLvector4f *normal,
184 GLfloat *norm = normal->start;
197 STRIDE_F(norm, normal
100 build_m3( GLfloat f[][3], GLfloat m[], const GLvector4f *normal, const GLvector4f *eye ) argument
127 build_m2( GLfloat f[][3], GLfloat m[], const GLvector4f *normal, const GLvector4f *eye ) argument
175 build_f3( GLfloat *f, GLuint fstride, const GLvector4f *normal, const GLvector4f *eye ) argument
202 build_f2( GLfloat *f, GLuint fstride, const GLvector4f *normal, const GLvector4f *eye ) argument
280 GLvector4f *normal = VB->AttribPtr[_TNL_ATTRIB_NORMAL]; local
345 const GLvector4f *normal = VB->AttribPtr[_TNL_ATTRIB_NORMAL]; local
[all...]
H A Dt_vb_lighttmp.h60 const GLfloat *normal = (GLfloat *)VB->AttribPtr[_TNL_ATTRIB_NORMAL]->data; local
89 for (j = 0; j < nr; j++,STRIDE_F(vertex,vstride),STRIDE_F(normal,nstride)) {
159 /* Compute dot product or normal and vector from V to light pos */
160 n_dot_VP = DOT3( normal, VP );
204 n_dot_h = correction * DOT3(normal, h);
243 const GLfloat *normal = (GLfloat *)VB->AttribPtr[_TNL_ATTRIB_NORMAL]->data; local
267 for (j = 0; j < nr; j++,STRIDE_F(vertex,vstride),STRIDE_F(normal,nstride)) {
337 /* Compute dot product or normal and vector from V to light pos */
338 n_dot_VP = DOT3( normal, VP );
383 n_dot_h = correction * DOT3(normal,
418 const GLfloat *normal = (GLfloat *)VB->AttribPtr[_TNL_ATTRIB_NORMAL]->data; local
523 const GLfloat *normal = (GLfloat *)VB->AttribPtr[_TNL_ATTRIB_NORMAL]->data; local
[all...]
H A Dt_rasterpos.c111 * \param normal normal vector
118 const GLfloat normal[3],
177 n_dot_VP = DOT3( normal, VP );
212 n_dot_h = DOT3(normal, h);
254 * \param normal vertex normal
260 const GLfloat normal[3], GLuint unit, GLfloat texcoord[4])
268 two_nu = 2.0F * DOT3(normal, u);
269 rx = u[0] - normal[
116 shade_rastpos(struct gl_context *ctx, const GLfloat vertex[4], const GLfloat normal[3], GLfloat Rcolor[4], GLfloat Rspec[4]) argument
259 compute_texgen(struct gl_context *ctx, const GLfloat vObj[4], const GLfloat vEye[4], const GLfloat normal[3], GLuint unit, GLfloat texcoord[4]) argument
[all...]
/external/replicaisland/src/com/replica/replicaisland/
H A DSolidSurfaceComponent.java75 public void addSurface(Vector2 startPoint, Vector2 endPoint, Vector2 normal) { argument
78 mNormals.add(normal);
95 Vector2 normal = mNormal;
118 normal.set(normals.get(x));
120 normal.flipHorizontal(0);
124 normal.flipVertical(0);
127 collision.addTemporarySurface(start, end, normal, parentObject);
/external/skia/src/core/
H A DSkStrokerPriv.cpp12 static void ButtCapper(SkPath* path, const SkPoint& pivot, const SkVector& normal, argument
17 static void RoundCapper(SkPath* path, const SkPoint& pivot, const SkVector& normal, argument
20 normal.rotateCW(&parallel);
24 path->conicTo(projectedCenter + normal, projectedCenter, SK_ScalarRoot2Over2);
25 path->conicTo(projectedCenter - normal, stop, SK_ScalarRoot2Over2);
28 static void SquareCapper(SkPath* path, const SkPoint& pivot, const SkVector& normal, argument
31 normal.rotateCW(&parallel);
34 path->setLastPt(pivot.fX + normal.fX + parallel.fX, pivot.fY + normal.fY + parallel.fY);
35 path->lineTo(pivot.fX - normal
[all...]
H A DSkStrokerPriv.h25 const SkVector& normal,
/external/apache-commons-math/src/main/java/org/apache/commons/math/distribution/
H A DPoissonDistributionImpl.java51 /** Distribution used to compute normal approximation. */
52 private NormalDistribution normal; field in class:PoissonDistributionImpl
128 * @param z a normal distribution used to compute normal approximations.
159 setNormalAndMeanInternal(normal, p);
176 normal = z;
177 normal.setMean(p);
178 normal.setStandardDeviation(FastMath.sqrt(p));
223 * Calculates the Poisson distribution function using a normal
227 * The computation uses "half-correction" -- evaluating the normal
[all...]
/external/webrtc/webrtc/modules/audio_coding/neteq/
H A Dnormal_unittest.cc13 #include "webrtc/modules/audio_coding/neteq/normal.h"
42 Normal normal(fs, &db, bgn, &expand);
57 Normal normal(fs, &db, bgn, &expand);
69 normal.Process(input, 0, kModeExpand, mute_factor_array.get(), &output));
82 normal.Process(input,
103 Normal normal(fs, &db, bgn, &expand);
116 normal.Process(
/external/iproute2/netem/
H A DMakefile1 DISTGEN = maketable normal pareto paretonormal
2 DISTDATA = normal.dist pareto.dist paretonormal.dist experimental.dist
H A Dnormal.c18 normal(double x, double mu, double sigma) function
32 i = rint(TABLESIZE * normal(x, 0.0, 1.0));
37 printf("# This is the distribution table for the normal distribution.\n");
H A Dparetonormal.c4 * This distribution is simply .25*normal + .75*pareto; a combination
27 normal(double x, double mu, double sigma) function
57 i = rint(TABLESIZE*normal(x, 0.0, 1.0));
/external/mesa3d/src/gallium/state_trackers/vega/
H A Dbezier.h77 float *point, float *normal);
79 float *point, float *normal);
/external/autotest/client/site_tests/graphics_SanAngeles/src/
H A Dshader.c87 static void computeNormalMatrix(Matrix4x4 m, Matrix3x3 normal) argument
93 normal[0*3+0] = invDet * (m[1*4+1] * m[2*4+2] - m[2*4+1] * m[1*4+2]);
94 normal[1*3+0] = invDet * -(m[0*4+1] * m[2*4+2] - m[0*4+2] * m[2*4+1]);
95 normal[2*3+0] = invDet * (m[0*4+1] * m[1*4+2] - m[0*4+2] * m[1*4+1]);
96 normal[0*3+1] = invDet * -(m[1*4+0] * m[2*4+2] - m[1*4+2] * m[2*4+0]);
97 normal[1*3+1] = invDet * (m[0*4+0] * m[2*4+2] - m[0*4+2] * m[2*4+0]);
98 normal[2*3+1] = invDet * -(m[0*4+0] * m[1*4+2] - m[1*4+0] * m[0*4+2]);
99 normal[0*3+2] = invDet * (m[1*4+0] * m[2*4+1] - m[2*4+0] * m[1*4+1]);
100 normal[1*3+2] = invDet * -(m[0*4+0] * m[2*4+1] - m[2*4+0] * m[0*4+1]);
101 normal[
[all...]
H A Dshader.h19 GLint normal; member in struct:__anon505
/external/swiftshader/src/Shader/
H A DVertexPipeline.hpp34 void processTextureCoordinate(int stage, Vector4f &normal, Vector4f &position);
/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/interpolation/
H A DMicrosphereInterpolatingFunction.java67 private final RealVector normal; field in class:MicrosphereInterpolatingFunction.MicrosphereSurfaceElement
80 normal = new ArrayRealVector(n);
84 * Return the normal vector.
85 * @return the normal vector
87 RealVector normal() { method in class:MicrosphereInterpolatingFunction.MicrosphereSurfaceElement
88 return normal;
212 md.store(cosAngle(diff, md.normal()) * w, sd);
/external/eigen/test/
H A Dgeo_hyperplane.cpp52 VERIFY_IS_MUCH_SMALLER_THAN( pl1.absDistance(p1 + pl1.normal().unitOrthogonal() * s1), Scalar(1) );
69 VERIFY_IS_APPROX( pl2.normal().norm(), RealScalar(1) );
73 VERIFY_IS_APPROX( pl2.normal().norm(), RealScalar(1) );
77 VERIFY_IS_APPROX( pl2.normal().norm(), RealScalar(1) );
111 VERIFY_IS_APPROX(line_u.normal().norm(), Scalar(1));
112 VERIFY_IS_APPROX(line_v.normal().norm(), Scalar(1));
124 if(line_u2.normal().dot(line_u.normal())<Scalar(0))
149 VERIFY_IS_APPROX(p0.normal().norm(), Scalar(1));
/external/skia/src/effects/
H A DSkDiscretePathEffect.cpp28 SkVector normal = tangent; local
29 normal.rotateCCW();
30 normal.setLength(scale);
31 *p += normal;
/external/webrtc/webrtc/modules/audio_processing/beamformer/
H A Darray_util.cc108 const rtc::Optional<Point> normal = GetNormalIfPlanar(array_geometry); local
109 if (normal && normal->z() < kMaxDotProduct) {
110 return normal;
/external/llvm/include/llvm/
H A DPassInfo.h51 NormalCtor_t normal, bool isCFGOnly, bool is_analysis,
54 IsAnalysis(is_analysis), IsAnalysisGroup(false), NormalCtor(normal),
81 /// isAnalysisGroup - Return true if this is an analysis group, not a normal
50 PassInfo(const char *name, const char *arg, const void *pi, NormalCtor_t normal, bool isCFGOnly, bool is_analysis, TargetMachineCtor_t machine = nullptr) argument

Completed in 988 milliseconds

123456789