diff --git a/tests/libslic3r/Simplify.h b/tests/libslic3r/Simplify.h deleted file mode 100644 index 24c126e34..000000000 --- a/tests/libslic3r/Simplify.h +++ /dev/null @@ -1,1036 +0,0 @@ -///////////////////////////////////////////// -// -// Mesh Simplification Tutorial -// -// (C) by Sven Forstmann in 2014 -// -// License : MIT -// http://opensource.org/licenses/MIT -// -//https://github.com/sp4cerat/Fast-Quadric-Mesh-Simplification -// -// 5/2016: Chris Rorden created minimal version for OSX/Linux/Windows compile - -//#include -//#include -//#include -//#include -//#include -#include -//#include -//#include -#include -#include -#include -#include -#include -#include -#include //FLT_EPSILON, DBL_EPSILON - -#define loopi(start_l,end_l) for ( int i=start_l;i1) input=1; - return (double) acos ( input ); - } - - inline double angle2( const vec3f& v , const vec3f& w ) - { - vec3f a = v , b= *this; - double dot = a.x*b.x + a.y*b.y + a.z*b.z; - double len = a.length() * b.length(); - if(len==0)len=1; - - vec3f plane; plane.cross( b,w ); - - if ( plane.x * a.x + plane.y * a.y + plane.z * a.z > 0 ) - return (double) -acos ( dot / len ); - - return (double) acos ( dot / len ); - } - - inline vec3f rot_x( double a ) - { - double yy = cos ( a ) * y + sin ( a ) * z; - double zz = cos ( a ) * z - sin ( a ) * y; - y = yy; z = zz; - return *this; - } - inline vec3f rot_y( double a ) - { - double xx = cos ( -a ) * x + sin ( -a ) * z; - double zz = cos ( -a ) * z - sin ( -a ) * x; - x = xx; z = zz; - return *this; - } - inline void clamp( double min, double max ) - { - if (xmax) x=max; - if (y>max) y=max; - if (z>max) z=max; - } - inline vec3f rot_z( double a ) - { - double yy = cos ( a ) * y + sin ( a ) * x; - double xx = cos ( a ) * x - sin ( a ) * y; - y = yy; x = xx; - return *this; - } - inline vec3f invert() - { - x=-x;y=-y;z=-z;return *this; - } - inline vec3f frac() - { - return vec3f( - x-double(int(x)), - y-double(int(y)), - z-double(int(z)) - ); - } - - inline vec3f integer() - { - return vec3f( - double(int(x)), - double(int(y)), - double(int(z)) - ); - } - - inline double length() const - { - return (double)sqrt(x*x + y*y + z*z); - } - - inline vec3f normalize( double desired_length = 1 ) - { - double square = sqrt(x*x + y*y + z*z); - /* - if (square <= 0.00001f ) - { - x=1;y=0;z=0; - return *this; - }*/ - //double len = desired_length / square; - x/=square;y/=square;z/=square; - - return *this; - } - static vec3f normalize( vec3f a ); - - static void random_init(); - static double random_double(); - static vec3f random(); - - static int random_number; - - double random_double_01(double a){ - double rnf=a*14.434252+a*364.2343+a*4213.45352+a*2341.43255+a*254341.43535+a*223454341.3523534245+23453.423412; - int rni=((int)rnf)%100000; - return double(rni)/(100000.0f-1.0f); - } - - vec3f random01_fxyz(){ - x=(double)random_double_01(x); - y=(double)random_double_01(y); - z=(double)random_double_01(z); - return *this; - } - -}; - -vec3f barycentric(const vec3f &p, const vec3f &a, const vec3f &b, const vec3f &c){ - vec3f v0 = b-a; - vec3f v1 = c-a; - vec3f v2 = p-a; - double d00 = v0.dot(v0); - double d01 = v0.dot(v1); - double d11 = v1.dot(v1); - double d20 = v2.dot(v0); - double d21 = v2.dot(v1); - double denom = d00*d11-d01*d01; - double v = (d11 * d20 - d01 * d21) / denom; - double w = (d00 * d21 - d01 * d20) / denom; - double u = 1.0 - v - w; - return vec3f(u,v,w); -} - -vec3f interpolate(const vec3f &p, const vec3f &a, const vec3f &b, const vec3f &c, const vec3f attrs[3]) -{ - vec3f bary = barycentric(p,a,b,c); - vec3f out = vec3f(0,0,0); - out = out + attrs[0] * bary.x; - out = out + attrs[1] * bary.y; - out = out + attrs[2] * bary.z; - return out; -} - -double min(double v1, double v2) { - return fmin(v1,v2); -} - - -class SymetricMatrix { - - public: - - // Constructor - - SymetricMatrix(double c=0) { loopi(0,10) m[i] = c; } - - SymetricMatrix( double m11, double m12, double m13, double m14, - double m22, double m23, double m24, - double m33, double m34, - double m44) { - m[0] = m11; m[1] = m12; m[2] = m13; m[3] = m14; - m[4] = m22; m[5] = m23; m[6] = m24; - m[7] = m33; m[8] = m34; - m[9] = m44; - } - - // Make plane - - SymetricMatrix(double a,double b,double c,double d) - { - m[0] = a*a; m[1] = a*b; m[2] = a*c; m[3] = a*d; - m[4] = b*b; m[5] = b*c; m[6] = b*d; - m[7 ] =c*c; m[8 ] = c*d; - m[9 ] = d*d; - } - - double operator[](int c) const { return m[c]; } - - // Determinant - - double det( int a11, int a12, int a13, - int a21, int a22, int a23, - int a31, int a32, int a33) - { - double det = m[a11]*m[a22]*m[a33] + m[a13]*m[a21]*m[a32] + m[a12]*m[a23]*m[a31] - - m[a13]*m[a22]*m[a31] - m[a11]*m[a23]*m[a32]- m[a12]*m[a21]*m[a33]; - return det; - } - - const SymetricMatrix operator+(const SymetricMatrix& n) const - { - return SymetricMatrix( m[0]+n[0], m[1]+n[1], m[2]+n[2], m[3]+n[3], - m[4]+n[4], m[5]+n[5], m[6]+n[6], - m[ 7]+n[ 7], m[ 8]+n[8 ], - m[ 9]+n[9 ]); - } - - SymetricMatrix& operator+=(const SymetricMatrix& n) - { - m[0]+=n[0]; m[1]+=n[1]; m[2]+=n[2]; m[3]+=n[3]; - m[4]+=n[4]; m[5]+=n[5]; m[6]+=n[6]; m[7]+=n[7]; - m[8]+=n[8]; m[9]+=n[9]; - return *this; - } - - double m[10]; -}; -/////////////////////////////////////////// - -namespace Simplify -{ - // Global Variables & Strctures - enum Attributes { - NONE, - NORMAL = 2, - TEXCOORD = 4, - COLOR = 8 - }; - struct Triangle { int v[3];double err[4];int deleted,dirty,attr;vec3f n;vec3f uvs[3];int material; }; - struct Vertex { vec3f p;int tstart,tcount;SymetricMatrix q;int border;}; - struct Ref { int tid,tvertex; }; - std::vector triangles; - std::vector vertices; - std::vector refs; - std::string mtllib; - std::vector materials; - - // Helper functions - - double vertex_error(SymetricMatrix q, double x, double y, double z); - double calculate_error(int id_v1, int id_v2, vec3f &p_result); - bool flipped(vec3f p,int i0,int i1,Vertex &v0,Vertex &v1,std::vector &deleted); - void update_uvs(int i0,const Vertex &v,const vec3f &p,std::vector &deleted); - void update_triangles(int i0,Vertex &v,std::vector &deleted,int &deleted_triangles); - void update_mesh(int iteration); - void compact_mesh(); - // - // Main simplification function - // - // target_count : target nr. of triangles - // agressiveness : sharpness to increase the threshold. - // 5..8 are good numbers - // more iterations yield higher quality - // - - void simplify_mesh(int target_count, double agressiveness=7, bool verbose=false) - { - // init - loopi(0,triangles.size()) - { - triangles[i].deleted=0; - } - - // main iteration loop - int deleted_triangles=0; - std::vector deleted0,deleted1; - int triangle_count=triangles.size(); - //int iteration = 0; - //loop(iteration,0,100) - for (int iteration = 0; iteration < 100; iteration ++) - { - if(triangle_count-deleted_triangles<=target_count)break; - - // update mesh once in a while - if(iteration%5==0) - { - update_mesh(iteration); - } - - // clear dirty flag - loopi(0,triangles.size()) triangles[i].dirty=0; - - // - // All triangles with edges below the threshold will be removed - // - // The following numbers works well for most models. - // If it does not, try to adjust the 3 parameters - // - double threshold = 0.000000001*pow(double(iteration+3),agressiveness); - - // target number of triangles reached ? Then break - if ((verbose) && (iteration%5==0)) { - printf("iteration %d - triangles %d threshold %g\n",iteration,triangle_count-deleted_triangles, threshold); - } - - // remove vertices & mark deleted triangles - loopi(0,triangles.size()) - { - Triangle &t=triangles[i]; - if(t.err[3]>threshold) continue; - if(t.deleted) continue; - if(t.dirty) continue; - - loopj(0,3)if(t.err[j] deleted0,deleted1; - int triangle_count=triangles.size(); - //int iteration = 0; - //loop(iteration,0,100) - for (int iteration = 0; iteration < 9999; iteration ++) - { - // update mesh constantly - update_mesh(iteration); - // clear dirty flag - loopi(0,triangles.size()) triangles[i].dirty=0; - // - // All triangles with edges below the threshold will be removed - // - // The following numbers works well for most models. - // If it does not, try to adjust the 3 parameters - // - double threshold = DBL_EPSILON; //1.0E-3 EPS; - if (verbose) { - printf("lossless iteration %d\n", iteration); - } - - // remove vertices & mark deleted triangles - loopi(0,triangles.size()) - { - Triangle &t=triangles[i]; - if(t.err[3]>threshold) continue; - if(t.deleted) continue; - if(t.dirty) continue; - - loopj(0,3)if(t.err[j] &deleted) - { - - loopk(0,v0.tcount) - { - Triangle &t=triangles[refs[v0.tstart+k].tid]; - if(t.deleted)continue; - - int s=refs[v0.tstart+k].tvertex; - int id1=t.v[(s+1)%3]; - int id2=t.v[(s+2)%3]; - - if(id1==i1 || id2==i1) // delete ? - { - - deleted[k]=1; - continue; - } - vec3f d1 = vertices[id1].p-p; d1.normalize(); - vec3f d2 = vertices[id2].p-p; d2.normalize(); - if(fabs(d1.dot(d2))>0.999) return true; - vec3f n; - n.cross(d1,d2); - n.normalize(); - deleted[k]=0; - if(n.dot(t.n)<0.2) return true; - } - return false; - } - - // update_uvs - - void update_uvs(int i0,const Vertex &v,const vec3f &p,std::vector &deleted) - { - loopk(0,v.tcount) - { - Ref &r=refs[v.tstart+k]; - Triangle &t=triangles[r.tid]; - if(t.deleted)continue; - if(deleted[k])continue; - vec3f p1=vertices[t.v[0]].p; - vec3f p2=vertices[t.v[1]].p; - vec3f p3=vertices[t.v[2]].p; - t.uvs[r.tvertex] = interpolate(p,p1,p2,p3,t.uvs); - } - } - - // Update triangle connections and edge error after a edge is collapsed - - void update_triangles(int i0,Vertex &v,std::vector &deleted,int &deleted_triangles) - { - vec3f p; - loopk(0,v.tcount) - { - Ref &r=refs[v.tstart+k]; - Triangle &t=triangles[r.tid]; - if(t.deleted)continue; - if(deleted[k]) - { - t.deleted=1; - deleted_triangles++; - continue; - } - t.v[r.tvertex]=i0; - t.dirty=1; - t.err[0]=calculate_error(t.v[0],t.v[1],p); - t.err[1]=calculate_error(t.v[1],t.v[2],p); - t.err[2]=calculate_error(t.v[2],t.v[0],p); - t.err[3]=min(t.err[0],min(t.err[1],t.err[2])); - refs.push_back(r); - } - } - - // compact triangles, compute edge error and build reference list - - void update_mesh(int iteration) - { - if(iteration>0) // compact triangles - { - int dst=0; - loopi(0,triangles.size()) - if(!triangles[i].deleted) - { - triangles[dst++]=triangles[i]; - } - triangles.resize(dst); - } - // - // Init Quadrics by Plane & Edge Errors - // - // required at the beginning ( iteration == 0 ) - // recomputing during the simplification is not required, - // but mostly improves the result for closed meshes - // - if( iteration == 0 ) - { - loopi(0,vertices.size()) - vertices[i].q=SymetricMatrix(0.0); - - loopi(0,triangles.size()) - { - Triangle &t=triangles[i]; - vec3f n,p[3]; - loopj(0,3) p[j]=vertices[t.v[j]].p; - n.cross(p[1]-p[0],p[2]-p[0]); - n.normalize(); - t.n=n; - loopj(0,3) vertices[t.v[j]].q = - vertices[t.v[j]].q+SymetricMatrix(n.x,n.y,n.z,-n.dot(p[0])); - } - loopi(0,triangles.size()) - { - // Calc Edge Error - Triangle &t=triangles[i];vec3f p; - loopj(0,3) t.err[j]=calculate_error(t.v[j],t.v[(j+1)%3],p); - t.err[3]=min(t.err[0],min(t.err[1],t.err[2])); - } - } - - // Init Reference ID list - loopi(0,vertices.size()) - { - vertices[i].tstart=0; - vertices[i].tcount=0; - } - loopi(0,triangles.size()) - { - Triangle &t=triangles[i]; - loopj(0,3) vertices[t.v[j]].tcount++; - } - int tstart=0; - loopi(0,vertices.size()) - { - Vertex &v=vertices[i]; - v.tstart=tstart; - tstart+=v.tcount; - v.tcount=0; - } - - // Write References - refs.resize(triangles.size()*3); - loopi(0,triangles.size()) - { - Triangle &t=triangles[i]; - loopj(0,3) - { - Vertex &v=vertices[t.v[j]]; - refs[v.tstart+v.tcount].tid=i; - refs[v.tstart+v.tcount].tvertex=j; - v.tcount++; - } - } - - // Identify boundary : vertices[].border=0,1 - if( iteration == 0 ) - { - std::vector vcount,vids; - - loopi(0,vertices.size()) - vertices[i].border=0; - - loopi(0,vertices.size()) - { - Vertex &v=vertices[i]; - vcount.clear(); - vids.clear(); - loopj(0,v.tcount) - { - int k=refs[v.tstart+j].tid; - Triangle &t=triangles[k]; - loopk(0,3) - { - int ofs=0,id=t.v[k]; - while(ofs try to find best result - vec3f p1=vertices[id_v1].p; - vec3f p2=vertices[id_v2].p; - vec3f p3=(p1+p2)/2; - double error1 = vertex_error(q, p1.x,p1.y,p1.z); - double error2 = vertex_error(q, p2.x,p2.y,p2.z); - double error3 = vertex_error(q, p3.x,p3.y,p3.z); - error = min(error1, min(error2, error3)); - if (error1 == error) p_result=p1; - if (error2 == error) p_result=p2; - if (error3 == error) p_result=p3; - } - return error; - } - - char *trimwhitespace(char *str) - { - char *end; - - // Trim leading space - while(isspace((unsigned char)*str)) str++; - - if(*str == 0) // All spaces? - return str; - - // Trim trailing space - end = str + strlen(str) - 1; - while(end > str && isspace((unsigned char)*end)) end--; - - // Write new null terminator - *(end+1) = 0; - - return str; - } - - //Option : Load OBJ - void load_obj(const char* filename, bool process_uv=false){ - vertices.clear(); - triangles.clear(); - //printf ( "Loading Objects %s ... \n",filename); - FILE* fn; - if(filename==NULL) return ; - if((char)filename[0]==0) return ; - if ((fn = fopen(filename, "rb")) == NULL) - { - printf ( "File %s not found!\n" ,filename ); - return; - } - char line[1000]; - memset ( line,0,1000 ); - int vertex_cnt = 0; - int material = -1; - std::map material_map; - std::vector uvs; - std::vector > uvMap; - - while(fgets( line, 1000, fn ) != NULL) - { - Vertex v; - vec3f uv; - - if (strncmp(line, "mtllib", 6) == 0) - { - mtllib = trimwhitespace(&line[7]); - } - if (strncmp(line, "usemtl", 6) == 0) - { - std::string usemtl = trimwhitespace(&line[7]); - if (material_map.find(usemtl) == material_map.end()) - { - material_map[usemtl] = materials.size(); - materials.push_back(usemtl); - } - material = material_map[usemtl]; - } - - if ( line[0] == 'v' && line[1] == 't' ) - { - if ( line[2] == ' ' ) - if(sscanf(line,"vt %lf %lf", - &uv.x,&uv.y)==2) - { - uv.z = 0; - uvs.push_back(uv); - } else - if(sscanf(line,"vt %lf %lf %lf", - &uv.x,&uv.y,&uv.z)==3) - { - uvs.push_back(uv); - } - } - else if ( line[0] == 'v' ) - { - if ( line[1] == ' ' ) - if(sscanf(line,"v %lf %lf %lf", - &v.p.x, &v.p.y, &v.p.z)==3) - { - vertices.push_back(v); - } - } - int integers[9]; - if ( line[0] == 'f' ) - { - Triangle t; - bool tri_ok = false; - bool has_uv = false; - - if(sscanf(line,"f %d %d %d", - &integers[0],&integers[1],&integers[2])==3) - { - tri_ok = true; - }else - if(sscanf(line,"f %d// %d// %d//", - &integers[0],&integers[1],&integers[2])==3) - { - tri_ok = true; - }else - if(sscanf(line,"f %d//%d %d//%d %d//%d", - &integers[0],&integers[3], - &integers[1],&integers[4], - &integers[2],&integers[5])==6) - { - tri_ok = true; - }else - if(sscanf(line,"f %d/%d/%d %d/%d/%d %d/%d/%d", - &integers[0],&integers[6],&integers[3], - &integers[1],&integers[7],&integers[4], - &integers[2],&integers[8],&integers[5])==9) - { - tri_ok = true; - has_uv = true; - }else // Add Support for v/vt only meshes - if (sscanf(line, "f %d/%d %d/%d %d/%d", - &integers[0], &integers[6], - &integers[1], &integers[7], - &integers[2], &integers[8]) == 6) - { - tri_ok = true; - has_uv = true; - } - else - { - printf("unrecognized sequence\n"); - printf("%s\n",line); - while(1); - } - if ( tri_ok ) - { - t.v[0] = integers[0]-1-vertex_cnt; - t.v[1] = integers[1]-1-vertex_cnt; - t.v[2] = integers[2]-1-vertex_cnt; - t.attr = 0; - - if ( process_uv && has_uv ) - { - std::vector indices; - indices.push_back(integers[6]-1-vertex_cnt); - indices.push_back(integers[7]-1-vertex_cnt); - indices.push_back(integers[8]-1-vertex_cnt); - uvMap.push_back(indices); - t.attr |= TEXCOORD; - } - - t.material = material; - //geo.triangles.push_back ( tri ); - triangles.push_back(t); - //state_before = state; - //state ='f'; - } - } - } - - if ( process_uv && uvs.size() ) - { - loopi(0,triangles.size()) - { - loopj(0,3) - triangles[i].uvs[j] = uvs[uvMap[i][j]]; - } - } - - fclose(fn); - - //printf("load_obj: vertices = %lu, triangles = %lu, uvs = %lu\n", vertices.size(), triangles.size(), uvs.size() ); - } // load_obj() - - // Optional : Store as OBJ - - void write_obj(const char* filename) - { - FILE *file=fopen(filename, "w"); - int cur_material = -1; - bool has_uv = (triangles.size() && (triangles[0].attr & TEXCOORD) == TEXCOORD); - - if (!file) - { - printf("write_obj: can't write data file \"%s\".\n", filename); - exit(0); - } - if (!mtllib.empty()) - { - fprintf(file, "mtllib %s\n", mtllib.c_str()); - } - loopi(0,vertices.size()) - { - //fprintf(file, "v %lf %lf %lf\n", vertices[i].p.x,vertices[i].p.y,vertices[i].p.z); - fprintf(file, "v %g %g %g\n", vertices[i].p.x,vertices[i].p.y,vertices[i].p.z); //more compact: remove trailing zeros - } - if (has_uv) - { - loopi(0,triangles.size()) if(!triangles[i].deleted) - { - fprintf(file, "vt %g %g\n", triangles[i].uvs[0].x, triangles[i].uvs[0].y); - fprintf(file, "vt %g %g\n", triangles[i].uvs[1].x, triangles[i].uvs[1].y); - fprintf(file, "vt %g %g\n", triangles[i].uvs[2].x, triangles[i].uvs[2].y); - } - } - int uv = 1; - loopi(0,triangles.size()) if(!triangles[i].deleted) - { - if (triangles[i].material != cur_material) - { - cur_material = triangles[i].material; - fprintf(file, "usemtl %s\n", materials[triangles[i].material].c_str()); - } - if (has_uv) - { - fprintf(file, "f %d/%d %d/%d %d/%d\n", triangles[i].v[0]+1, uv, triangles[i].v[1]+1, uv+1, triangles[i].v[2]+1, uv+2); - uv += 3; - } - else - { - fprintf(file, "f %d %d %d\n", triangles[i].v[0]+1, triangles[i].v[1]+1, triangles[i].v[2]+1); - } - //fprintf(file, "f %d// %d// %d//\n", triangles[i].v[0]+1, triangles[i].v[1]+1, triangles[i].v[2]+1); //more compact: remove trailing zeros - } - fclose(file); - } -}; -/////////////////////////////////////////// diff --git a/tests/libslic3r/test_quadric_edge_collapse.cpp b/tests/libslic3r/test_quadric_edge_collapse.cpp index 19b7dede7..3ae44d561 100644 --- a/tests/libslic3r/test_quadric_edge_collapse.cpp +++ b/tests/libslic3r/test_quadric_edge_collapse.cpp @@ -240,7 +240,6 @@ TEST_CASE("Simplify frog_legs.obj to 5% by Quadric edge collapse", "[its][quadri } #include -#include "Simplify.h" TEST_CASE("Simplify frog_legs.obj to 5% by IGL/qslim", "[]") { std::string obj_filename = "frog_legs.obj"; @@ -285,32 +284,6 @@ TEST_CASE("Simplify frog_legs.obj to 5% by IGL/qslim", "[]") // its, its_out --> avg_distance: 0.0412358, max_distance 0.238913 } -TEST_CASE("Simplify frog_legs.obj to 5% by simplify", "[]") { - std::string obj_filename = "frog_legs.obj"; - TriangleMesh mesh = load_model(obj_filename); - uint32_t wanted_count = mesh.its.indices.size() * 0.05; - Simplify::load_obj((TEST_DATA_DIR PATH_SEPARATOR + obj_filename).c_str()); - Simplify::simplify_mesh(wanted_count, 5, true); - - // convert to its - indexed_triangle_set its_out; - its_out.vertices.reserve(Simplify::vertices.size()); - its_out.indices.reserve(Simplify::triangles.size()); - for (size_t i = 0; i < Simplify::vertices.size(); i++) { - const Simplify::Vertex &v = Simplify::vertices[i]; - its_out.vertices.emplace_back(v.p.x, v.p.y, v.p.z); - } - for (size_t i = 0; i < Simplify::triangles.size(); i++) { - const Simplify::Triangle &t = Simplify::triangles[i]; - its_out.indices.emplace_back(t.v[0], t.v[1], t.v[2]); - } - - // check if algorithm is still worse than our - Private::is_worse_similarity(its_out, mesh.its, Private::frog_leg_5); - // its_out, mesh.its --> max_distance = 0.700494, average_distance = 0.0902524 - // mesh.its, its_out --> max_distance = 0.393184, average_distance = 0.0537392 -} - TEST_CASE("Simplify trouble case", "[its]") { TriangleMesh tm = load_model("simplification.obj");