• 设为首页
  • 点击收藏
  • 手机版
    手机扫一扫访问
    迪恩网络手机版
  • 关注官方公众号
    微信扫一扫关注
    公众号

C++ Intersection函数代码示例

原作者: [db:作者] 来自: [db:来源] 收藏 邀请

本文整理汇总了C++中Intersection函数的典型用法代码示例。如果您正苦于以下问题:C++ Intersection函数的具体用法?C++ Intersection怎么用?C++ Intersection使用的例子?那么恭喜您, 这里精选的函数代码示例或许可以为您提供帮助。



在下文中一共展示了Intersection函数的20个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于我们的系统推荐出更棒的C++代码示例。

示例1: cross

	Intersection Triangle::intersect(const Ray& ray, float previousBestDistance) const
	{
		Vector a,b,c,rayO;
		a=tvertices[0]-Point(0,0,0);
		b=tvertices[1]-Point(0,0,0);
		c=tvertices[2]-Point(0,0,0);
		rayO=ray.o-Point(0,0,0);
		/*Vector nab=cross(tvertices[1]-ray.o,tvertices[0]-ray.o);
		Vector nbc=cross(tvertices[2]-ray.o,tvertices[1]-ray.o);
		Vector nca=cross(tvertices[0]-ray.o,tvertices[2]-ray.o);*/
		Vector nab=cross(b-rayO,a-rayO);
		Vector nbc=cross(c-rayO,b-rayO);
		Vector nca=cross(a-rayO,c-rayO);
		float dotab=dot(nab,ray.d);
		float dotbc=dot(nbc,ray.d);
		float dotca=dot(nca,ray.d);
		
		if((dotab>0 && dotbc>0 && dotca>0) ||(dotab<0 && dotbc<0 && dotca<0))
		{
			Vector vect0 = (b - a);
			Vector vect1 = (c - a);

			Vector tnormal = cross(vect0, vect1).normalize(); // triangle normal on vertix a

			float factor= dot(ray.d,tnormal);
			if(abs(factor-0.0)<0.00001) 
				return Intersection::failure();

			float sumIv = 1.0f / (dotab + dotbc + dotca);
			float l2 = dotab * sumIv;
			float l0 = dotbc * sumIv;
			float l1 = dotca * sumIv;

			Point pp = l0 * tvertices[0] + l1 * tvertices[1] + l2 * tvertices[2];

			Vector direction = pp - ray.o;

			float orientation = dot(direction, ray.d);
			float distance = direction.length();

			if(distance>previousBestDistance || orientation<0.000001) 
				return Intersection::failure();

			//Point p=ray.getPoint(distance);
			// here instead of p i can also give barycentric coordinates but why should I
			return Intersection(distance,ray,this,tnormal,Point(l0,l1,l2));
		}
		return Intersection::failure();
	}
开发者ID:joniali,项目名称:Cg-Saar-RayTracer,代码行数:49,代码来源:triangle.cpp


示例2: configure

	void configure() {
		unsigned int extraFlags = 0;
		if (!m_sigmaA->isConstant() || !m_alpha->isConstant())
			extraFlags |= ESpatiallyVarying;

		m_components.clear();
		for (int i=0; i<m_nested->getComponentCount(); ++i)
			m_components.push_back(m_nested->getType(i) | extraFlags);

		m_components.push_back(EGlossyReflection | EFrontSide | EBackSide
			| (m_specularReflectance->isConstant() ? 0 : ESpatiallyVarying));

		m_usesRayDifferentials = m_nested->usesRayDifferentials()
			|| m_sigmaA->usesRayDifferentials()
			|| m_alpha->usesRayDifferentials()
			|| m_specularReflectance->usesRayDifferentials();

		/* Compute weights that further steer samples towards
		   the specular or nested components */
		Float avgAbsorption = (m_sigmaA->getAverage()
			 *(-2*m_thickness)).exp().average();

		m_specularSamplingWeight = 1.0f / (avgAbsorption + 1.0f);

		/* Verify the input parameters and fix them if necessary */
		m_specularReflectance = ensureEnergyConservation(
			m_specularReflectance, "specularReflectance", 1.0f);

		if (!m_roughTransmittance.get()) {
			/* Load precomputed data used to compute the rough
			   transmittance through the dielectric interface */
			m_roughTransmittance = new RoughTransmittance(
				m_distribution.getType());

			m_roughTransmittance->checkEta(m_eta);
			m_roughTransmittance->checkAlpha(m_alpha->getMinimum().average());
			m_roughTransmittance->checkAlpha(m_alpha->getMaximum().average());

			/* Reduce the rough transmittance data to a 2D slice */
			m_roughTransmittance->setEta(m_eta);

			/* If possible, even reduce it to a 1D slice */
			if (m_alpha->isConstant())
				m_roughTransmittance->setAlpha(
					m_alpha->eval(Intersection()).average());
		}

		BSDF::configure();
	}
开发者ID:blckshrk,项目名称:IFT6042,代码行数:49,代码来源:roughcoating.cpp


示例3: main

int main(int argc, char **argv) {
    struct LL list1, list2;

    list1.Next = NULL;
    list2.Next = NULL;

    ReadList("5_1.txt", &list1);
    ReadList("5_2.txt", &list2);

    Print(list1.Next);
    Print(list2.Next);

    Print(Intersection(list1.Next, list2.Next).Next);
    Print(Union(list1.Next, list2.Next).Next);
}
开发者ID:infyhr,项目名称:FELB03,代码行数:15,代码来源:5.c


示例4: randomf

Intersection SquarePlane::pickSampleIntersection(std::function<float ()> randomf, const glm::vec3 *target_normal)
{
     float random1 = randomf();
     float random2 = randomf();
     auto point_obj = glm::vec3(random1 - 0.5f, random2 - 0.5f, 0.f);
     auto point = glm::vec3(this->transform.T() *
                      glm::vec4(point_obj, 1.f));
     auto normal = glm::normalize(glm::vec3(this->transform.invTransT() *
                             glm::vec4(0,0,1.f,0.f)));
     auto tangent = glm::normalize(glm::vec3(this->transform.invTransT() *
                             glm::vec4(1.f,0,0,0.f)));
     auto color = Material::GetImageColorInterp(this->GetUVCoordinates(point_obj), this->material->texture);

     return Intersection(point, normal, tangent, 0.f, color, this);
}
开发者ID:WindyDarian,项目名称:HomeworkPathTracer,代码行数:15,代码来源:square.cpp


示例5: assert

void UICurvePoint::ForceContinuousTanget()
{
    if(m_point->mOnCurve)
    {
        int numPts = m_contour->NumPoints();
        
        // find index of this point in the contour
        int ptIndex = -1;
        for(int i = 0; i < numPts; i++)
        {
            if(m_point == m_contour->GetPoint(i))
            {
                ptIndex = i;
                break;
            }
        }
        
        // this point should exist in the contour
        // otherwise theres a problem!
        assert(ptIndex != -1);
        
        TTPoint * ptM1 = m_contour->GetPoint(wrapTo(ptIndex-1, numPts));
        TTPoint * ptP1 = m_contour->GetPoint(wrapTo(ptIndex+1, numPts));
        if(!ptM1->mOnCurve && !ptP1->mOnCurve)
        {
            // translate to origin
            STVector2 trM1 = ptM1->mCoordinates - m_point->mCoordinates;
            // translate to origin
            STVector2 trP1 = ptP1->mCoordinates - m_point->mCoordinates;
            // normalize
            trP1.Normalize();
            // point previous tangent in opposite direction with same length
            trM1 = STVector2(-trP1.x, -trP1.y) * trM1.Length();
            // translate back
            ptM1->mCoordinates = m_point->mCoordinates + trM1;
            
            // don't disturb tangents of other points
            TTPoint * ptM2 = m_contour->GetPoint(wrapTo(ptIndex-2, numPts));
            if(ptM2->mOnCurve)
            {
                TTPoint * ptM3 = m_contour->GetPoint(wrapTo(ptIndex-3, numPts));
                Intersection(m_point->mCoordinates, ptM1->mCoordinates,
                             ptM2->mCoordinates, ptM3->mCoordinates,
                             ptM1->mCoordinates);
            }
        }
    }
}
开发者ID:JinshengRuan,项目名称:cs148,代码行数:48,代码来源:UICurvePoint.cpp


示例6: Intersection

std::vector<NumberRange> NumberSet::getIntersection(const NumberRange& r) const
{
    std::vector<NumberRange> Result;
    RangeListTypeConstItor ListItor;
    
    NumberRange Intersection(0,0);
    for (ListItor = _List.begin() ; ListItor != _List.end() ; ++ListItor )
    {
        Intersection = intersection( (*ListItor),r);
        if(!Intersection.isEmpty())
        {
            Result.push_back(Intersection);
        }
    }
    return Result;
}
开发者ID:Himbeertoni,项目名称:OpenSGToolbox,代码行数:16,代码来源:OSGNumberRangeSet.cpp


示例7: CanvasPixbuf

void TextWidget::PaintRegion(const Rect& rct)
{
    RefPtr<Gdk::Pixbuf> pix = CanvasPixbuf();
    Rect drw_rct = Intersection(rct, PixbufBounds(pix));
    if( drw_rct.IsNull() )
        return;

    AlignCairoVsPixbuf(pix, drw_rct);

    RefPtr<Gdk::Window> p_win = get_window();
    Rect dst_rct = Planed::RelToDev(trans, drw_rct);
    p_win->draw_pixbuf(get_style()->get_black_gc(), CanvasPixbuf(),
                       drw_rct.lft, drw_rct.top, 
                       dst_rct.lft, dst_rct.top, dst_rct.Width(), dst_rct.Height(), 
                       Gdk::RGB_DITHER_NORMAL, 0, 0);
}
开发者ID:cargabsj175,项目名称:bombono-dvd,代码行数:16,代码来源:test_text.cpp


示例8: Intersection

void Ctrl::DrawLine(const Vector<Rect>& clip, int x, int y, int cx, int cy, bool horz, const byte *pattern, int animation)
{
	if(cx <= 0 || cy <= 0)
		return;
	Vector<Rect> rr = Intersection(clip, RectC(x, y, cx, cy));
	for(int i = 0; i < rr.GetCount(); i++) {
		Rect r = rr[i];
		AddUpdate(r);
		if(horz)
			for(int y = r.top; y < r.bottom; y++)
				DDRect(framebuffer[y] + r.left, 1, pattern, r.left + animation, r.GetWidth());
		else
			for(int x = r.left; x < r.right; x++)
				DDRect(framebuffer[r.top] + x, framebuffer.GetWidth(), pattern, r.top + animation, r.GetHeight());
	}
}
开发者ID:AbdelghaniDr,项目名称:mirror,代码行数:16,代码来源:Wnd.cpp


示例9: intersect

	bool AABB_Tree_Node ::  intersect(Ray& ray, Intersection* in){
		if (child[0]){
			bool intersected1 = false;
			bool intersected2 = false;
			if ((*child[0]).b_box->intersect(ray)){
				intersected1 = (*child[0]).intersect(ray,in);
			}
			if ((*child[1]).b_box->intersect(ray)){
				intersected2 = (*child[1]).intersect(ray,in);
			}
			if (intersected1 || intersected2){
				return true;
			}else{
				return false;
			}
		}else{
			if(my_shapes.size() == 0){
				return false;
			} else{
				bool intersected = false;
				float t = in->t;
				vector<Shape*>::iterator shape;
				for (shape = my_shapes.begin(); shape != my_shapes.end(); shape++){
					Intersection temp = Intersection();
					if((*shape)->intersect(ray, &temp)){
						intersected = true;
						if (t == 0.0 || t > temp.t){
							t = temp.t;
							in->local = temp.local;
							in->shape = temp.shape;
							in->t = temp.t;
						}
						/*else if (t = temp.t){
							if((in->shape->brdf.caustic) && (!temp.shape->brdf.caustic)){
								t = temp.t;
								in->local = temp.local;
								in->shape = temp.shape;
								in->t = temp.t;
								intersected = true;
							}
						}*/
					}	
				}
				return intersected;
			}
		}
	}
开发者ID:pedrotanaka,项目名称:CS184-Final-Project,代码行数:47,代码来源:AABB_Tree_Node.cpp


示例10: intersectionRayTriangleOpt

Intersection intersectionRayTriangleOpt(const VEC3& P, const VEC3& Dir, const VEC3& Ta, const VEC3& Tb, const VEC3& Tc, VEC3& Inter)
{
	typedef typename VEC3::DATA_TYPE T ;

	VEC3 u = Ta - P ;
	VEC3 v = Tb - P ;
	VEC3 w = Tc - P ;

	T x = tripleProduct(Dir, u, v) ;
	T y = tripleProduct(Dir, v, w) ;
	T z = tripleProduct(Dir, w, u) ;

	unsigned int np = 0 ;
	unsigned int nn = 0 ;
	unsigned int nz = 0 ;

	if (x > T(0))
		++np ;
	else if (x < T(0))
		++nn ;
	else
		++nz ;

	if (y > T(0))
		++np ;
	else if (y < T(0))
		++nn ;
	else
		++nz ;

	if (z > T(0))
		++np ;
	else if (z < T(0))
		++nn ;
	else
		++nz ;

	if ((np != 0) && (nn != 0)) return NO_INTERSECTION ;

	T sum = x + y + z ;
	T alpha = y / sum ;
	T beta = z / sum ;
	T gamma = T(1) - alpha - beta ;
	Inter = Ta * alpha + Tb * beta + Tc * gamma ;

	return Intersection(FACE_INTERSECTION - nz) ;
}
开发者ID:Peiffert,项目名称:CGoGN,代码行数:47,代码来源:intersection.hpp


示例11: findNewShiftState

static a_pro *analyseParents( a_state *state, a_pro *pro, a_word *reduce_set )
{
    a_pro *test_pro;
    a_pro *new_pro;
    a_sym *old_lhs;
    a_state *parent_state;
    a_state *new_state;
    a_parent *parent;
    a_parent *split_parent;
    a_reduce_action *raction;

    split_parent = NULL;
    new_pro = NULL;
    old_lhs = pro->sym;
    for( parent = state->parents; parent != NULL; parent = parent->next ) {
        parent_state = parent->state;
        new_state = findNewShiftState( parent_state, old_lhs );
        if( new_state == NULL ) {
            printf( "error! %u %s %u\n", state->sidx, old_lhs->name, parent_state->sidx );
            exit(1);
        }
        for( raction = new_state->redun; (test_pro = raction->pro) != NULL; ++raction ) {
            if( !test_pro->unit ) {
                continue;
            }
            if( EmptyIntersection( reduce_set, raction->follow ) ) {
                continue;
            }
            if( new_pro == NULL ) {
                new_pro = test_pro;
            } else if( new_pro != test_pro ) {
                new_pro = NULL;
                break;
            }
            /* we have a reduce of a unit rule on similar tokens */
            Intersection( reduce_set, raction->follow );
            break;
        }
        if( new_pro == NULL || test_pro == NULL ) {
            split_parent = parent;
        }
    }
    if( Empty( reduce_set ) || split_parent != NULL ) {
        new_pro = NULL;
    }
    return( new_pro );
}
开发者ID:Azarien,项目名称:open-watcom-v2,代码行数:47,代码来源:elimunit.c


示例12: Intersection

bool AggregatePrimitive::intersect(Ray ray, float* t_hit, Intersection* in){
	Intersection nextIn = Intersection();
	float nextT = INFINITY;
	float currT = INFINITY;
	bool hit = false;
	for (size_t i = 0; i < primitives.size(); i++){
		if (primitives[i]->intersect(ray, &nextT, &nextIn)){
			hit = true;
			if (nextT < currT){
				currT = nextT;
				*t_hit = currT;
				*in = nextIn;
			}
		}
	}
	return hit;
}
开发者ID:akrolsmir,项目名称:Raytracer,代码行数:17,代码来源:primitive.cpp


示例13: Intersection

bool A3DLine::Intersection(const A3DLine& line, A3DPoint *pt) const
{
	double t1 = 0.0, t2 = 0.0;
	bool   f1, f2;

	f1 = Intersection(line, &t1); 
	f2 = line.Intersection(*this, &t2);

	if (pt) {
		pt->x = pt->y = pt->z = 0.0;
		if (f1) *pt += Start      + t1 * Vector;
		if (f2) *pt += line.Start + t2 * line.Vector;
		if (f1 && f2) *pt *= .5;
	}

	return (f1 || f2);
}
开发者ID:richardxday,项目名称:rdlib,代码行数:17,代码来源:3DTrans.cpp


示例14: clamp_response

  // Set non-zero velocity response if collision
  inline void clamp_response(Vector3D &p, Vector3D &v, double delta_t, BVHAccel *bvh) {
    Vector3D delta_p = v * delta_t;
    double total_l = delta_p.norm(), l = total_l;
    if (l <= EPS_D) {
      return;
    }
    Vector3D d = delta_p / l;
    // Viewing from plane x = -1.0, clip it as well
    bool intersect = false;
    if (d.z != 0.0) {
      double pt = (1.0 - p.z) / d.z;
      if (pt > 0.0 && pt < l) {
        l = pt;
        intersect = true;
      }
    }
    // light is at y = 1.49.
    // to avoid particles being stuck between light and ceiling, clip it
    if (d.y != 0.0) {
      double pt = (1.49 - p.y) / d.y;
      if (pt > 0.0 && pt < l) {
        l = pt;
        intersect = true;
      }
    }
    Ray r(p, d, 0.0, l);
    Intersection i;
    if (bvh->intersect(r, &i) || intersect) {
      p += (r.max_t - EPS_D) * d;
      // hack. redirect ONCE
      // if not perpendicular
      if (dot(d, i.n) > -1 && !intersect) { //TODO: INTERSECT = true case
        d = (delta_p - dot(delta_p, i.n) * i.n).unit();
        r = Ray(p, d, 0.0, (total_l - r.max_t) * 0.5);
        i = Intersection();
        bvh->intersect(r, &i);
        p += (r.max_t - EPS_D) * d;
      }

    } else {
      p += delta_p;
    }
    p.x = max(-1.0 + EPS_D, min(1.0 - EPS_D, p.x));
    p.y = max(0.0 + EPS_D, min(1.49 - EPS_D, p.y));
    p.z = max(-1.0 + EPS_D, min(1.0 - EPS_D, p.z));
  }
开发者ID:SsnL,项目名称:Fluid,代码行数:47,代码来源:particles.cpp


示例15: searchTree

Intersection BVHTree::searchTree(BVHNode *n, Ray r) {
    if (n->leaf) {
        return n->shape->intersects(r);
    } else {
        if (n->bbox.intersects(r)) {
            Intersection i = searchTree(n->left, r);
            Intersection j = searchTree(n->right, r);

            if (i.hasIntersected() && j.hasIntersected()) {
                return i.getIntersectionPoint() < j.getIntersectionPoint() ? i : j;
            } else {
                return i.hasIntersected() ? i : j;
            }
        }
        return Intersection(r);
    }
}
开发者ID:sondrele,项目名称:NTNU,代码行数:17,代码来源:bvhtree.cpp


示例16: VEvaluateRay

bool Plane::All_Intersections(const Ray& ray, IStack& Depth_Stack, TraceThreadData *Thread)
{
	DBL Depth;
	VECTOR IPoint;

	if (Intersect(ray, &Depth, Thread))
	{
		VEvaluateRay(IPoint, ray.Origin, Depth, ray.Direction);

		if (Clip.empty() || Point_In_Clip(IPoint, Clip, Thread))
		{
			Depth_Stack->push(Intersection(Depth,IPoint,this));
			return(true);
		}
	}

	return(false);
}
开发者ID:Degot,项目名称:povray,代码行数:18,代码来源:planes.cpp


示例17: All_Intersections

bool Plane::All_Intersections(const Ray& ray, IStack& Depth_Stack, TraceThreadData *Thread)
{
    DBL Depth;
    Vector3d IPoint;

    if (Intersect(ray, &Depth, Thread))
    {
        IPoint = ray.Evaluate(Depth);

        if (Clip.empty() || Point_In_Clip(IPoint, Clip, Thread))
        {
            Depth_Stack->push(Intersection(Depth,IPoint,this));
            return(true);
        }
    }

    return(false);
}
开发者ID:dickbalaska,项目名称:povray,代码行数:18,代码来源:plane.cpp


示例18: intersect

 			Intersection intersect(Ray const& ray) const {
 				auto isec1 = t1_.intersect(ray);
 				auto isec2 = t2_.intersect(ray);

 				if (isec1.hit && isec2.hit) {
 					if (isec1.t < isec2.t) {
 						return isec1;
 					} else {
 						return isec2;
 					}
 				} else if (isec1.hit) {
 					return isec1;
 				} else if (isec2.hit) {
 					return isec2;
 				}

 				return Intersection();
 			}
开发者ID:RTBULJ15,项目名称:programmiersprachen-raytracer,代码行数:18,代码来源:Box.hpp


示例19: test_hit

bool Lathe::test_hit(const BasicRay &ray, IStack& Depth_Stack, DBL d, DBL w, int n, TraceThreadData *Thread)
{
    Vector3d IPoint;

    if ((d > DEPTH_TOLERANCE) && (d < MAX_DISTANCE))
    {
        IPoint = ray.Evaluate(d);

        if (Clip.empty() || Point_In_Clip(IPoint, Clip, Thread))
        {
            Depth_Stack->push(Intersection(d, IPoint, this, n, w));

            return(true);
        }
    }

    return(false);
}
开发者ID:neuroradiology,项目名称:povray,代码行数:18,代码来源:lathe.cpp


示例20: setValues

bool Spank::CheckCollision(Ship* shipA, Astroid* astroidB)
{
    setValues(shipA, astroidB);
	SDL_Rect collisionRect = Intersection(boundsA, boundsB);

	if(collisionRect.w == 0 && collisionRect.h == 0)
		return false;

	SDL_Rect normalA = NormalizeBounds(collisionRect, true);//spriteA
	SDL_Rect normalB = NormalizeBounds(collisionRect, false);//spriteB

	for(int y = 0; y < collisionRect.h; y++)
		for(int x = 0; x < collisionRect.w; x++)
			if(GetAlphaXY(shipA, normalA.x + x, normalA.y + y) && GetAlphaXY(astroidB, normalB.x + x, normalB.y + y))
				return true;

	return false;
}
开发者ID:mcteapot,项目名称:Astroids,代码行数:18,代码来源:Spank.cpp



注:本文中的Intersection函数示例由纯净天空整理自Github/MSDocs等源码及文档管理平台,相关代码片段筛选自各路编程大神贡献的开源项目,源码版权归原作者所有,传播和使用请参考对应项目的License;未经允许,请勿转载。


鲜花

握手

雷人

路过

鸡蛋
该文章已有0人参与评论

请发表评论

全部评论

专题导读
上一篇:
C++ Intersects函数代码示例发布时间:2022-05-30
下一篇:
C++ IntersectRect函数代码示例发布时间:2022-05-30
热门推荐
阅读排行榜

扫描微信二维码

查看手机版网站

随时了解更新最新资讯

139-2527-9053

在线客服(服务时间 9:00~18:00)

在线QQ客服
地址:深圳市南山区西丽大学城创智工业园
电邮:jeky_zhao#qq.com
移动电话:139-2527-9053

Powered by 互联科技 X3.4© 2001-2213 极客世界.|Sitemap