py_doc.cpp 57 KB

123456789101112131415161718192021222324252627282930313233343536373839404142434445464748495051525354555657585960616263646566676869707172737475767778798081828384858687888990919293949596979899100101102103104105106107108109110111112113114115116117118119120121122123124125126127128129130131132133134135136137138139140141142143144145146147148149150151152153154155156157158159160161162163164165166167168169170171172173174175176177178179180181182183184185186187188189190191192193194195196197198199200201202203204205206207208209210211212213214215216217218219220221222223224225226227228229230231232233234235236237238239240241242243244245246247248249250251252253254255256257258259260261262263264265266267268269270271272273274275276277278279280281282283284285286287288289290291292293294295296297298299300301302303304305306307308309310311312313314315316317318319320321322323324325326327328329330331332333334335336337338339340341342343344345346347348349350351352353354355356357358359360361362363364365366367368369370371372373374375376377378379380381382383384385386387388389390391392393394395396397398399400401402403404405406407408409410411412413414415416417418419420421422423424425426427428429430431432433434435436437438439440441442443444445446447448449450451452453454455456457458459460461462463464465466467468469470471472473474475476477478479480481482483484485486487488489490491492493494495496497498499500501502503504505506507508509510511512513514515516517518519520521522523524525526527528529530531532533534535536537538539540541542543544545546547548549550551552553554555556557558559560561562563564565566567568569570571572573574575576577578579580581582583584585586587588589590591592593594595596597598599600601602603604605606607608609610611612613614615616617618619620621622623624625626627628629630631632633634635636637638639640641642643644645646647648649650651652653654655656657658659660661662663664665666667668669670671672673674675676677678679680681682683684685686687688689690691692693694695696697698699700701702703704705706707708709710711712713714715716717718719720721722723724725726727728729730731732733734735736737738739740741742743744745746747748749750751752753754755756757758759760761762763764765766767768769770771772773774775776777778779780781782783784785786787788789790791792793794795796797798799800801802803804805806807808809810811812813814815816817818819820821822823824825826827828829830831832833834835836837838839840841842843844845846847848849850851852853854855856857858859860861862863864865866867868869870871872873874875876877878879880881882883884885886887888889890891892893894895896897898899900901902903904905906907908909910911912913914915916917918919920921922923924925926927928929930931932933934935936937938939940941942943944945946947948949950951952953954955956957958959960961962963964965966967968969970971972973974975976977978979980981982983984985986987988989990991992993994995996997998999100010011002100310041005100610071008100910101011101210131014101510161017101810191020102110221023102410251026102710281029103010311032103310341035103610371038103910401041104210431044104510461047104810491050105110521053105410551056105710581059106010611062106310641065106610671068106910701071107210731074107510761077107810791080108110821083108410851086108710881089109010911092109310941095109610971098109911001101110211031104110511061107110811091110111111121113111411151116111711181119112011211122112311241125112611271128112911301131113211331134113511361137113811391140114111421143114411451146114711481149115011511152115311541155115611571158115911601161116211631164116511661167116811691170117111721173117411751176117711781179118011811182118311841185118611871188118911901191119211931194119511961197119811991200120112021203120412051206
  1. const char *__doc_igl_active_set = R"igl_Qu8mg5v7(// Known Bugs: rows of [Aeq;Aieq] **must** be linearly independent. Should be
  2. // using QR decomposition otherwise:
  3. // http://www.okstate.edu/sas/v8/sashtml/ormp/chap5/sect32.htm
  4. //
  5. // ACTIVE_SET Minimize quadratic energy
  6. //
  7. // 0.5*Z'*A*Z + Z'*B + C with constraints
  8. //
  9. // that Z(known) = Y, optionally also subject to the constraints Aeq*Z = Beq,
  10. // and further optionally subject to the linear inequality constraints that
  11. // Aieq*Z <= Bieq and constant inequality constraints lx <= x <= ux
  12. //
  13. // Inputs:
  14. // A n by n matrix of quadratic coefficients
  15. // B n by 1 column of linear coefficients
  16. // known list of indices to known rows in Z
  17. // Y list of fixed values corresponding to known rows in Z
  18. // Aeq meq by n list of linear equality constraint coefficients
  19. // Beq meq by 1 list of linear equality constraint constant values
  20. // Aieq mieq by n list of linear inequality constraint coefficients
  21. // Bieq mieq by 1 list of linear inequality constraint constant values
  22. // lx n by 1 list of lower bounds [] implies -Inf
  23. // ux n by 1 list of upper bounds [] implies Inf
  24. // params struct of additional parameters (see below)
  25. // Z if not empty, is taken to be an n by 1 list of initial guess values
  26. // (see output)
  27. // Outputs:
  28. // Z n by 1 list of solution values
  29. // Returns true on success, false on error
  30. //
  31. // Benchmark: For a harmonic solve on a mesh with 325K facets, matlab 2.2
  32. // secs, igl/min_quad_with_fixed.h 7.1 secs
  33. //)igl_Qu8mg5v7";
  34. const char *__doc_igl_arap_precomputation = R"igl_Qu8mg5v7(// Compute necessary information to start using an ARAP deformation
  35. //
  36. // Inputs:
  37. // V #V by dim list of mesh positions
  38. // F #F by simplex-size list of triangle|tet indices into V
  39. // dim dimension being used at solve time. For deformation usually dim =
  40. // V.cols(), for surface parameterization V.cols() = 3 and dim = 2
  41. // b #b list of "boundary" fixed vertex indices into V
  42. // Outputs:
  43. // data struct containing necessary precomputation)igl_Qu8mg5v7";
  44. const char *__doc_igl_arap_solve = R"igl_Qu8mg5v7(// Inputs:
  45. // bc #b by dim list of boundary conditions
  46. // data struct containing necessary precomputation and parameters
  47. // U #V by dim initial guess)igl_Qu8mg5v7";
  48. const char *__doc_igl_avg_edge_length = R"igl_Qu8mg5v7(// Compute the average edge length for the given triangle mesh
  49. // Templates:
  50. // DerivedV derived from vertex positions matrix type: i.e. MatrixXd
  51. // DerivedF derived from face indices matrix type: i.e. MatrixXi
  52. // DerivedL derived from edge lengths matrix type: i.e. MatrixXd
  53. // Inputs:
  54. // V eigen matrix #V by 3
  55. // F #F by simplex-size list of mesh faces (must be simplex)
  56. // Outputs:
  57. // l average edge length
  58. //
  59. // See also: adjacency_matrix)igl_Qu8mg5v7";
  60. const char *__doc_igl_barycenter = R"igl_Qu8mg5v7(// Computes the barycenter of every simplex
  61. //
  62. // Inputs:
  63. // V #V x dim matrix of vertex coordinates
  64. // F #F x simplex_size matrix of indices of simplex corners into V
  65. // Output:
  66. // BC #F x dim matrix of 3d vertices
  67. //)igl_Qu8mg5v7";
  68. const char *__doc_igl_barycentric_coordinates = R"igl_Qu8mg5v7(// Compute barycentric coordinates in a tet
  69. //
  70. // Inputs:
  71. // P #P by 3 Query points in 3d
  72. // A #P by 3 Tet corners in 3d
  73. // B #P by 3 Tet corners in 3d
  74. // C #P by 3 Tet corners in 3d
  75. // D #P by 3 Tet corners in 3d
  76. // Outputs:
  77. // L #P by 4 list of barycentric coordinates
  78. // )igl_Qu8mg5v7";
  79. const char *__doc_igl_boundary_facets = R"igl_Qu8mg5v7(// BOUNDARY_FACETS Determine boundary faces (edges) of tetrahedra (triangles)
  80. // stored in T (analogous to qptoolbox's `outline` and `boundary_faces`).
  81. //
  82. // Templates:
  83. // IntegerT integer-value: e.g. int
  84. // IntegerF integer-value: e.g. int
  85. // Input:
  86. // T tetrahedron (triangle) index list, m by 4 (3), where m is the number of tetrahedra
  87. // Output:
  88. // F list of boundary faces, n by 3 (2), where n is the number of boundary faces
  89. //
  90. //)igl_Qu8mg5v7";
  91. const char *__doc_igl_boundary_loop = R"igl_Qu8mg5v7(// Compute list of ordered boundary loops for a manifold mesh.
  92. //
  93. // Templates:
  94. // Index index type
  95. // Inputs:
  96. // F #V by dim list of mesh faces
  97. // Outputs:
  98. // L list of loops where L[i] = ordered list of boundary vertices in loop i
  99. //)igl_Qu8mg5v7";
  100. const char *__doc_igl_cat = R"igl_Qu8mg5v7(// Perform concatenation of a two matrices along a single dimension
  101. // If dim == 1, then C = [A;B]. If dim == 2 then C = [A B]
  102. //
  103. // Template:
  104. // Scalar scalar data type for sparse matrices like double or int
  105. // Mat matrix type for all matrices (e.g. MatrixXd, SparseMatrix)
  106. // MatC matrix type for ouput matrix (e.g. MatrixXd) needs to support
  107. // resize
  108. // Inputs:
  109. // A first input matrix
  110. // B second input matrix
  111. // dim dimension along which to concatenate, 0 or 1
  112. // Outputs:
  113. // C output matrix
  114. // )igl_Qu8mg5v7";
  115. const char *__doc_igl_collapse_edge = R"igl_Qu8mg5v7(See collapse_edge for the documentation.)igl_Qu8mg5v7";
  116. const char *__doc_igl_colon = R"igl_Qu8mg5v7(// Colon operator like matlab's colon operator. Enumerats values between low
  117. // and hi with step step.
  118. // Templates:
  119. // L should be a eigen matrix primitive type like int or double
  120. // S should be a eigen matrix primitive type like int or double
  121. // H should be a eigen matrix primitive type like int or double
  122. // T should be a eigen matrix primitive type like int or double
  123. // Inputs:
  124. // low starting value if step is valid then this is *always* the first
  125. // element of I
  126. // step step difference between sequential elements returned in I,
  127. // remember this will be cast to template T at compile time. If low<hi
  128. // then step must be positive. If low>hi then step must be negative.
  129. // Otherwise I will be set to empty.
  130. // hi ending value, if (hi-low)%step is zero then this will be the last
  131. // element in I. If step is positive there will be no elements greater
  132. // than hi, vice versa if hi<low
  133. // Output:
  134. // I list of values from low to hi with step size step)igl_Qu8mg5v7";
  135. const char *__doc_igl_comb_cross_field = R"igl_Qu8mg5v7(// Inputs:
  136. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  137. // F #F by 4 eigen Matrix of face (quad) indices
  138. // PD1in #F by 3 eigen Matrix of the first per face cross field vector
  139. // PD2in #F by 3 eigen Matrix of the second per face cross field vector
  140. // Output:
  141. // PD1out #F by 3 eigen Matrix of the first combed cross field vector
  142. // PD2out #F by 3 eigen Matrix of the second combed cross field vector
  143. //)igl_Qu8mg5v7";
  144. const char *__doc_igl_comb_frame_field = R"igl_Qu8mg5v7(// Inputs:
  145. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  146. // F #F by 4 eigen Matrix of face (quad) indices
  147. // PD1 #F by 3 eigen Matrix of the first per face cross field vector
  148. // PD2 #F by 3 eigen Matrix of the second per face cross field vector
  149. // BIS1_combed #F by 3 eigen Matrix of the first combed bisector field vector
  150. // BIS2_combed #F by 3 eigen Matrix of the second combed bisector field vector
  151. // Output:
  152. // PD1_combed #F by 3 eigen Matrix of the first combed cross field vector
  153. // PD2_combed #F by 3 eigen Matrix of the second combed cross field vector
  154. //)igl_Qu8mg5v7";
  155. const char *__doc_igl_compute_frame_field_bisectors = R"igl_Qu8mg5v7(// Compute bisectors of a frame field defined on mesh faces
  156. // Inputs:
  157. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  158. // F #F by 3 eigen Matrix of face (triangle) indices
  159. // B1 #F by 3 eigen Matrix of face (triangle) base vector 1
  160. // B2 #F by 3 eigen Matrix of face (triangle) base vector 2
  161. // PD1 #F by 3 eigen Matrix of the first per face frame field vector
  162. // PD2 #F by 3 eigen Matrix of the second per face frame field vector
  163. // Output:
  164. // BIS1 #F by 3 eigen Matrix of the first per face frame field bisector
  165. // BIS2 #F by 3 eigen Matrix of the second per face frame field bisector
  166. //)igl_Qu8mg5v7";
  167. const char *__doc_igl_copyleft_cgal_mesh_boolean = R"igl_Qu8mg5v7(// MESH_BOOLEAN Compute boolean csg operations on "solid", consistently
  168. // oriented meshes.
  169. //
  170. // Inputs:
  171. // VA #VA by 3 list of vertex positions of first mesh
  172. // FA #FA by 3 list of triangle indices into VA
  173. // VB #VB by 3 list of vertex positions of second mesh
  174. // FB #FB by 3 list of triangle indices into VB
  175. // type type of boolean operation
  176. // Outputs:
  177. // VC #VC by 3 list of vertex positions of boolean result mesh
  178. // FC #FC by 3 list of triangle indices into VC
  179. // J #FC list of indices into [FA;FA.rows()+FB] revealing "birth" facet
  180. // Returns true if inputs induce a piecewise constant winding number
  181. // field and type is valid
  182. //
  183. // See also: mesh_boolean_cork, intersect_other,
  184. // remesh_self_intersections)igl_Qu8mg5v7";
  185. const char *__doc_igl_copyleft_cgal_remesh_self_intersections = R"igl_Qu8mg5v7(// Given a triangle mesh (V,F) compute a new mesh (VV,FF) which is the same
  186. // as (V,F) except that any self-intersecting triangles in (V,F) have been
  187. // subdivided (new vertices and face created) so that the self-intersection
  188. // contour lies exactly on edges in (VV,FF). New vertices will appear in
  189. // original faces or on original edges. New vertices on edges are "merged"
  190. // only across original faces sharing that edge. This means that if the input
  191. // triangle mesh is a closed manifold the output will be too.
  192. //
  193. // Inputs:
  194. // V #V by 3 list of vertex positions
  195. // F #F by 3 list of triangle indices into V
  196. // params struct of optional parameters
  197. // Outputs:
  198. // VV #VV by 3 list of vertex positions
  199. // FF #FF by 3 list of triangle indices into VV
  200. // IF #intersecting face pairs by 2 list of intersecting face pairs,
  201. // indexing F
  202. // J #FF list of indices into F denoting birth triangle
  203. // IM #VV list of indices into VV of unique vertices.
  204. //
  205. // Known bugs: If an existing edge in (V,F) lies exactly on another face then
  206. // any resulting additional vertices along that edge may not get properly
  207. // connected so that the output mesh has the same global topology. This is
  208. // because
  209. //
  210. // Example:
  211. // // resolve intersections
  212. // igl::copyleft::cgal::remesh_self_intersections(V,F,params,VV,FF,IF,J,IM);
  213. // // _apply_ duplicate vertex mapping IM to FF
  214. // for_each(FF.data(),FF.data()+FF.size(),[&IM](int & a){a=IM(a);});
  215. // // remove any vertices now unreferenced after duplicate mapping.
  216. // igl::remove_unreferenced(VV,FF,SV,SF,UIM);
  217. // // Now (SV,SF) is ready to extract outer hull
  218. // igl::copyleft::cgal::outer_hull(SV,SF,G,J,flip);
  219. //)igl_Qu8mg5v7";
  220. const char *__doc_igl_copyleft_comiso_miq = R"igl_Qu8mg5v7(// Inputs:
  221. // V #V by 3 list of mesh vertex 3D positions
  222. // F #F by 3 list of faces indices in V
  223. // PD1 #V by 3 first line of the Jacobian per triangle
  224. // PD2 #V by 3 second line of the Jacobian per triangle
  225. // (optional, if empty it will be a vector in the tangent plane orthogonal to PD1)
  226. // scale global scaling for the gradient (controls the quads resolution)
  227. // stiffness weight for the stiffness iterations
  228. // direct_round greedily round all integer variables at once (greatly improves optimization speed but lowers quality)
  229. // iter stiffness iterations (0 = no stiffness)
  230. // local_iter number of local iterations for the integer rounding
  231. // do_round enables the integer rounding (disabling it could be useful for debugging)
  232. // round_vertices id of additional vertices that should be snapped to integer coordinates
  233. // hard_features #H by 2 list of pairs of vertices that belongs to edges that should be snapped to integer coordinates
  234. //
  235. // Output:
  236. // UV #UV by 2 list of vertices in 2D
  237. // FUV #FUV by 3 list of face indices in UV
  238. //
  239. // TODO: rename the parameters name in the cpp consistenly
  240. // improve the handling of hard_features, right now it might fail in difficult cases)igl_Qu8mg5v7";
  241. const char *__doc_igl_copyleft_comiso_nrosy = R"igl_Qu8mg5v7(// Generate a N-RoSy field from a sparse set of constraints
  242. //
  243. // Inputs:
  244. // V #V by 3 list of mesh vertex coordinates
  245. // F #F by 3 list of mesh faces (must be triangles)
  246. // b #B by 1 list of constrained face indices
  247. // bc #B by 3 list of representative vectors for the constrained
  248. // faces
  249. // b_soft #S by 1 b for soft constraints
  250. // w_soft #S by 1 weight for the soft constraints (0-1)
  251. // bc_soft #S by 3 bc for soft constraints
  252. // N the degree of the N-RoSy vector field
  253. // soft the strenght of the soft contraints w.r.t. smoothness
  254. // (0 -> smoothness only, 1->constraints only)
  255. // Outputs:
  256. // R #F by 3 the representative vectors of the interpolated field
  257. // S #V by 1 the singularity index for each vertex (0 = regular))igl_Qu8mg5v7";
  258. const char *__doc_igl_copyleft_marching_cubes = R"igl_Qu8mg5v7(// marching_cubes( values, points, x_res, y_res, z_res, vertices, faces )
  259. //
  260. // performs marching cubes reconstruction on the grid defined by values, and
  261. // points, and generates vertices and faces
  262. //
  263. // Input:
  264. // values #number_of_grid_points x 1 array -- the scalar values of an
  265. // implicit function defined on the grid points (<0 in the inside of the
  266. // surface, 0 on the border, >0 outside)
  267. // points #number_of_grid_points x 3 array -- 3-D positions of the grid
  268. // points, ordered in x,y,z order:
  269. // points[index] = the point at (x,y,z) where :
  270. // x = (index % (xres -1),
  271. // y = (index / (xres-1)) %(yres-1),
  272. // z = index / (xres -1) / (yres -1) ).
  273. // where x,y,z index x, y, z dimensions
  274. // i.e. index = x + y*xres + z*xres*yres
  275. // xres resolutions of the grid in x dimension
  276. // yres resolutions of the grid in y dimension
  277. // zres resolutions of the grid in z dimension
  278. // Output:
  279. // vertices #V by 3 list of mesh vertex positions
  280. // faces #F by 3 list of mesh triangle indices
  281. //)igl_Qu8mg5v7";
  282. const char *__doc_igl_copyleft_swept_volume = R"igl_Qu8mg5v7(// Compute the surface of the swept volume of a solid object with surface
  283. // (V,F) mesh under going rigid motion.
  284. //
  285. // Inputs:
  286. // V #V by 3 list of mesh positions in reference pose
  287. // F #F by 3 list of mesh indices into V
  288. // transform function handle so that transform(t) returns the rigid
  289. // transformation at time t∈[0,1]
  290. // steps number of time steps: steps=3 --> t∈{0,0.5,1}
  291. // grid_res number of grid cells on the longest side containing the
  292. // motion (isolevel+1 cells will also be added on each side as padding)
  293. // isolevel distance level to be contoured as swept volume
  294. // Outputs:
  295. // SV #SV by 3 list of mesh positions of the swept surface
  296. // SF #SF by 3 list of mesh faces into SV)igl_Qu8mg5v7";
  297. const char *__doc_igl_copyleft_tetgen_tetrahedralize = R"igl_Qu8mg5v7(// Mesh the interior of a surface mesh (V,F) using tetgen
  298. //
  299. // Inputs:
  300. // V #V by 3 vertex position list
  301. // F #F list of polygon face indices into V (0-indexed)
  302. // switches string of tetgen options (See tetgen documentation) e.g.
  303. // "pq1.414a0.01" tries to mesh the interior of a given surface with
  304. // quality and area constraints
  305. // "" will mesh the convex hull constrained to pass through V (ignores F)
  306. // Outputs:
  307. // TV #V by 3 vertex position list
  308. // TT #T by 4 list of tet face indices
  309. // TF #F by 3 list of triangle face indices
  310. // Returns status:
  311. // 0 success
  312. // 1 tetgen threw exception
  313. // 2 tetgen did not crash but could not create any tets (probably there are
  314. // holes, duplicate faces etc.)
  315. // -1 other error)igl_Qu8mg5v7";
  316. const char *__doc_igl_cotmatrix = R"igl_Qu8mg5v7(// Constructs the cotangent stiffness matrix (discrete laplacian) for a given
  317. // mesh (V,F).
  318. //
  319. // Templates:
  320. // DerivedV derived type of eigen matrix for V (e.g. derived from
  321. // MatrixXd)
  322. // DerivedF derived type of eigen matrix for F (e.g. derived from
  323. // MatrixXi)
  324. // Scalar scalar type for eigen sparse matrix (e.g. double)
  325. // Inputs:
  326. // V #V by dim list of mesh vertex positions
  327. // F #F by simplex_size list of mesh faces (must be triangles)
  328. // Outputs:
  329. // L #V by #V cotangent matrix, each row i corresponding to V(i,:)
  330. //
  331. // See also: adjacency_matrix
  332. //
  333. // Note: This Laplacian uses the convention that diagonal entries are
  334. // **minus** the sum of off-diagonal entries. The diagonal entries are
  335. // therefore in general negative and the matrix is **negative** semi-definite
  336. // (immediately, -L is **positive** semi-definite)
  337. //
  338. // Known bugs: off by 1e-16 on regular grid. I think its a problem of
  339. // arithmetic order in cotmatrix_entries.h: C(i,e) = (arithmetic)/dblA/4)igl_Qu8mg5v7";
  340. const char *__doc_igl_covariance_scatter_matrix = R"igl_Qu8mg5v7(// Construct the covariance scatter matrix for a given arap energy
  341. // Inputs:
  342. // V #V by Vdim list of initial domain positions
  343. // F #F by 3 list of triangle indices into V
  344. // energy ARAPEnergyType enum value defining which energy is being used.
  345. // See ARAPEnergyType.h for valid options and explanations.
  346. // Outputs:
  347. // CSM dim*#V/#F by dim*#V sparse matrix containing special laplacians along
  348. // the diagonal so that when multiplied by V gives covariance matrix
  349. // elements, can be used to speed up covariance matrix computation)igl_Qu8mg5v7";
  350. const char *__doc_igl_cross_field_missmatch = R"igl_Qu8mg5v7(// Inputs:
  351. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  352. // F #F by 3 eigen Matrix of face (quad) indices
  353. // PD1 #F by 3 eigen Matrix of the first per face cross field vector
  354. // PD2 #F by 3 eigen Matrix of the second per face cross field vector
  355. // isCombed boolean, specifying whether the field is combed (i.e. matching has been precomputed.
  356. // If not, the field is combed first.
  357. // Output:
  358. // Handle_MMatch #F by 3 eigen Matrix containing the integer missmatch of the cross field
  359. // across all face edges
  360. //)igl_Qu8mg5v7";
  361. const char *__doc_igl_cut_mesh_from_singularities = R"igl_Qu8mg5v7(// Given a mesh (V,F) and the integer mismatch of a cross field per edge
  362. // (MMatch), finds the cut_graph connecting the singularities (seams) and the
  363. // degree of the singularities singularity_index
  364. //
  365. // Input:
  366. // V #V by 3 list of mesh vertex positions
  367. // F #F by 3 list of faces
  368. // MMatch #F by 3 list of per corner integer mismatch
  369. // Outputs:
  370. // seams #F by 3 list of per corner booleans that denotes if an edge is a
  371. // seam or not
  372. //)igl_Qu8mg5v7";
  373. const char *__doc_igl_doublearea = R"igl_Qu8mg5v7(// DOUBLEAREA computes twice the area for each input triangle[quad]
  374. //
  375. // Templates:
  376. // DerivedV derived type of eigen matrix for V (e.g. derived from
  377. // MatrixXd)
  378. // DerivedF derived type of eigen matrix for F (e.g. derived from
  379. // MatrixXi)
  380. // DeriveddblA derived type of eigen matrix for dblA (e.g. derived from
  381. // MatrixXd)
  382. // Inputs:
  383. // V #V by dim list of mesh vertex positions
  384. // F #F by simplex_size list of mesh faces (must be triangles or quads)
  385. // Outputs:
  386. // dblA #F list of triangle[quad] double areas (SIGNED only for 2D input)
  387. //
  388. // Known bug: For dim==3 complexity is O(#V + #F)!! Not just O(#F). This is a big deal
  389. // if you have 1million unreferenced vertices and 1 face)igl_Qu8mg5v7";
  390. const char *__doc_igl_doublearea_single = R"igl_Qu8mg5v7(// Single triangle in 2D!
  391. //
  392. // This should handle streams of corners not just single corners)igl_Qu8mg5v7";
  393. const char *__doc_igl_doublearea_quad = R"igl_Qu8mg5v7(// DOUBLEAREA_QUAD computes twice the area for each input quadrilateral
  394. //
  395. // Inputs:
  396. // V #V by dim list of mesh vertex positions
  397. // F #F by simplex_size list of mesh faces (must be quadrilaterals)
  398. // Outputs:
  399. // dblA #F list of quadrilateral double areas
  400. //)igl_Qu8mg5v7";
  401. const char *__doc_igl_edge_lengths = R"igl_Qu8mg5v7(// Constructs a list of lengths of edges opposite each index in a face
  402. // (triangle/tet) list
  403. //
  404. // Templates:
  405. // DerivedV derived from vertex positions matrix type: i.e. MatrixXd
  406. // DerivedF derived from face indices matrix type: i.e. MatrixXi
  407. // DerivedL derived from edge lengths matrix type: i.e. MatrixXd
  408. // Inputs:
  409. // V eigen matrix #V by 3
  410. // F #F by 2 list of mesh edges
  411. // or
  412. // F #F by 3 list of mesh faces (must be triangles)
  413. // or
  414. // T #T by 4 list of mesh elements (must be tets)
  415. // Outputs:
  416. // L #F by {1|3|6} list of edge lengths
  417. // for edges, column of lengths
  418. // for triangles, columns correspond to edges [1,2],[2,0],[0,1]
  419. // for tets, columns correspond to edges
  420. // [3 0],[3 1],[3 2],[1 2],[2 0],[0 1]
  421. //)igl_Qu8mg5v7";
  422. const char *__doc_igl_edge_topology = R"igl_Qu8mg5v7(// Initialize Edges and their topological relations
  423. //
  424. // Output:
  425. // EV : #Ex2, Stores the edge description as pair of indices to vertices
  426. // FE : #Fx3, Stores the Triangle-Edge relation
  427. // EF : #Ex2: Stores the Edge-Triangle relation
  428. //
  429. // TODO: This seems to be a duplicate of edge_flaps.h)igl_Qu8mg5v7";
  430. const char *__doc_igl_eigs = R"igl_Qu8mg5v7(See eigs for the documentation.)igl_Qu8mg5v7";
  431. const char *__doc_igl_embree_ambient_occlusion = R"igl_Qu8mg5v7(// Compute ambient occlusion per given point
  432. //
  433. // Inputs:
  434. // ei EmbreeIntersector containing (V,F)
  435. // P #P by 3 list of origin points
  436. // N #P by 3 list of origin normals
  437. // Outputs:
  438. // S #P list of ambient occlusion values between 1 (fully occluded) and
  439. // 0 (not occluded)
  440. //)igl_Qu8mg5v7";
  441. const char *__doc_igl_embree_reorient_facets_raycast = R"igl_Qu8mg5v7(// Orient each component (identified by C) of a mesh (V,F) using ambient
  442. // occlusion such that the front side is less occluded than back side, as
  443. // described in "A Simple Method for Correcting Facet Orientations in
  444. // Polygon Meshes Based on Ray Casting" [Takayama et al. 2014].
  445. //
  446. // Inputs:
  447. // V #V by 3 list of vertex positions
  448. // F #F by 3 list of triangle indices
  449. // rays_total Total number of rays that will be shot
  450. // rays_minimum Minimum number of rays that each patch should receive
  451. // facet_wise Decision made for each face independently, no use of patches
  452. // (i.e., each face is treated as a patch)
  453. // use_parity Use parity mode
  454. // is_verbose Verbose output to cout
  455. // Outputs:
  456. // I #F list of whether face has been flipped
  457. // C #F list of patch ID (output of bfs_orient > manifold patches))igl_Qu8mg5v7";
  458. const char *__doc_igl_find_cross_field_singularities = R"igl_Qu8mg5v7(// Inputs:
  459. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  460. // F #F by 3 eigen Matrix of face (quad) indices
  461. // Handle_MMatch #F by 3 eigen Matrix containing the integer missmatch of the cross field
  462. // across all face edges
  463. // Output:
  464. // isSingularity #V by 1 boolean eigen Vector indicating the presence of a singularity on a vertex
  465. // singularityIndex #V by 1 integer eigen Vector containing the singularity indices
  466. //)igl_Qu8mg5v7";
  467. const char *__doc_igl_fit_rotations = R"igl_Qu8mg5v7(// Known issues: This seems to be implemented in Eigen/Geometry:
  468. // Eigen::umeyama
  469. //
  470. // FIT_ROTATIONS Given an input mesh and new positions find rotations for
  471. // every covariance matrix in a stack of covariance matrices
  472. //
  473. // Inputs:
  474. // S nr*dim by dim stack of covariance matrices
  475. // single_precision whether to use single precision (faster)
  476. // Outputs:
  477. // R dim by dim * nr list of rotations
  478. //)igl_Qu8mg5v7";
  479. const char *__doc_igl_fit_rotations_planar = R"igl_Qu8mg5v7(// FIT_ROTATIONS Given an input mesh and new positions find 2D rotations for
  480. // every vertex that best maps its one ring to the new one ring
  481. //
  482. // Inputs:
  483. // S nr*dim by dim stack of covariance matrices, third column and every
  484. // third row will be ignored
  485. // Outputs:
  486. // R dim by dim * nr list of rotations, third row and third column of each
  487. // rotation will just be identity
  488. //)igl_Qu8mg5v7";
  489. const char *__doc_igl_fit_rotations_SSE = R"igl_Qu8mg5v7(See fit_rotations_SSE for the documentation.)igl_Qu8mg5v7";
  490. const char *__doc_igl_floor = R"igl_Qu8mg5v7(// Floor a given matrix to nearest integers
  491. //
  492. // Inputs:
  493. // X m by n matrix of scalars
  494. // Outputs:
  495. // Y m by n matrix of floored integers)igl_Qu8mg5v7";
  496. const char *__doc_igl_gaussian_curvature = R"igl_Qu8mg5v7(// Compute discrete local integral gaussian curvature (angle deficit, without
  497. // averaging by local area).
  498. //
  499. // Inputs:
  500. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  501. // F #F by 3 eigen Matrix of face (triangle) indices
  502. // Output:
  503. // K #V by 1 eigen Matrix of discrete gaussian curvature values
  504. //)igl_Qu8mg5v7";
  505. const char *__doc_igl_get_seconds = R"igl_Qu8mg5v7(// Return the current time in seconds since program start
  506. //
  507. // Example:
  508. // const auto & tictoc = []()
  509. // {
  510. // static double t_start = igl::get_seconds();
  511. // double diff = igl::get_seconds()-t_start;
  512. // t_start += diff;
  513. // return diff;
  514. // };
  515. // tictoc();
  516. // ... // part 1
  517. // cout<<"part 1: "<<tictoc()<<endl;
  518. // ... // part 2
  519. // cout<<"part 2: "<<tictoc()<<endl;
  520. // ... // etc)igl_Qu8mg5v7";
  521. const char *__doc_igl_grad = R"igl_Qu8mg5v7(// Gradient of a scalar function defined on piecewise linear elements (mesh)
  522. // is constant on each triangle i,j,k:
  523. // grad(Xijk) = (Xj-Xi) * (Vi - Vk)^R90 / 2A + (Xk-Xi) * (Vj - Vi)^R90 / 2A
  524. // where Xi is the scalar value at vertex i, Vi is the 3D position of vertex
  525. // i, and A is the area of triangle (i,j,k). ^R90 represent a rotation of
  526. // 90 degrees
  527. //)igl_Qu8mg5v7";
  528. const char *__doc_igl_harmonic = R"igl_Qu8mg5v7(// Compute k-harmonic weight functions "coordinates".
  529. //
  530. //
  531. // Inputs:
  532. // V #V by dim vertex positions
  533. // F #F by simplex-size list of element indices
  534. // b #b boundary indices into V
  535. // bc #b by #W list of boundary values
  536. // k power of harmonic operation (1: harmonic, 2: biharmonic, etc)
  537. // Outputs:
  538. // W #V by #W list of weights
  539. //)igl_Qu8mg5v7";
  540. const char *__doc_igl_hsv_to_rgb = R"igl_Qu8mg5v7(// Convert RGB to HSV
  541. //
  542. // Inputs:
  543. // h hue value (degrees: [0,360])
  544. // s saturation value ([0,1])
  545. // v value value ([0,1])
  546. // Outputs:
  547. // r red value ([0,1])
  548. // g green value ([0,1])
  549. // b blue value ([0,1]))igl_Qu8mg5v7";
  550. const char *__doc_igl_internal_angles = R"igl_Qu8mg5v7(// Compute internal angles for a triangle mesh
  551. //
  552. // Inputs:
  553. // V #V by dim eigen Matrix of mesh vertex nD positions
  554. // F #F by poly-size eigen Matrix of face (triangle) indices
  555. // Output:
  556. // K #F by poly-size eigen Matrix of internal angles
  557. // for triangles, columns correspond to edges [1,2],[2,0],[0,1]
  558. //
  559. // Known Issues:
  560. // if poly-size ≠ 3 then dim must equal 3.)igl_Qu8mg5v7";
  561. const char *__doc_igl_invert_diag = R"igl_Qu8mg5v7(// Templates:
  562. // T should be a eigen sparse matrix primitive type like int or double
  563. // Inputs:
  564. // X an m by n sparse matrix
  565. // Outputs:
  566. // Y an m by n sparse matrix)igl_Qu8mg5v7";
  567. const char *__doc_igl_is_irregular_vertex = R"igl_Qu8mg5v7(// Determine if a vertex is irregular, i.e. it has more than 6 (triangles)
  568. // or 4 (quads) incident edges. Vertices on the boundary are ignored.
  569. //
  570. // Inputs:
  571. // V #V by dim list of vertex positions
  572. // F #F by 3[4] list of triangle[quads] indices
  573. // Returns #V vector of bools revealing whether vertices are singular
  574. //)igl_Qu8mg5v7";
  575. const char *__doc_igl_jet = R"igl_Qu8mg5v7(// JET like MATLAB's jet
  576. //
  577. // Inputs:
  578. // m number of colors
  579. // Outputs:
  580. // J m by list of RGB colors between 0 and 1
  581. //
  582. //#ifndef IGL_NO_EIGEN
  583. // void jet(const int m, Eigen::MatrixXd & J);
  584. //#endif
  585. // Wrapper for directly computing [r,g,b] values for a given factor f between
  586. // 0 and 1
  587. //
  588. // Inputs:
  589. // f factor determining color value as if 0 was min and 1 was max
  590. // Outputs:
  591. // r red value
  592. // g green value
  593. // b blue value)igl_Qu8mg5v7";
  594. const char *__doc_igl_local_basis = R"igl_Qu8mg5v7(// Compute a local orthogonal reference system for each triangle in the given mesh
  595. // Templates:
  596. // DerivedV derived from vertex positions matrix type: i.e. MatrixXd
  597. // DerivedF derived from face indices matrix type: i.e. MatrixXi
  598. // Inputs:
  599. // V eigen matrix #V by 3
  600. // F #F by 3 list of mesh faces (must be triangles)
  601. // Outputs:
  602. // B1 eigen matrix #F by 3, each vector is tangent to the triangle
  603. // B2 eigen matrix #F by 3, each vector is tangent to the triangle and perpendicular to B1
  604. // B3 eigen matrix #F by 3, normal of the triangle
  605. //
  606. // See also: adjacency_matrix)igl_Qu8mg5v7";
  607. const char *__doc_igl_lscm = R"igl_Qu8mg5v7(// Compute a Least-squares conformal map parametrization (equivalently
  608. // derived in "Intrinsic Parameterizations of Surface Meshes" [Desbrun et al.
  609. // 2002] and "Least Squares Conformal Maps for Automatic Texture Atlas
  610. // Generation" [Lévy et al. 2002]), though this implementation follows the
  611. // derivation in: "Spectral Conformal Parameterization" [Mullen et al. 2008]
  612. // (note, this does **not** implement the Eigen-decomposition based method in
  613. // [Mullen et al. 2008], which is not equivalent). Input should be a manifold
  614. // mesh (also no unreferenced vertices) and "boundary" (fixed vertices) `b`
  615. // should contain at least two vertices per connected component.
  616. //
  617. // Inputs:
  618. // V #V by 3 list of mesh vertex positions
  619. // F #F by 3 list of mesh faces (must be triangles)
  620. // b #b boundary indices into V
  621. // bc #b by 3 list of boundary values
  622. // Outputs:
  623. // UV #V by 2 list of 2D mesh vertex positions in UV space
  624. // Returns true only on solver success.
  625. //)igl_Qu8mg5v7";
  626. const char *__doc_igl_map_vertices_to_circle = R"igl_Qu8mg5v7(// Map the vertices whose indices are in a given boundary loop (bnd) on the
  627. // unit circle with spacing proportional to the original boundary edge
  628. // lengths.
  629. //
  630. // Inputs:
  631. // V #V by dim list of mesh vertex positions
  632. // b #W list of vertex ids
  633. // Outputs:
  634. // UV #W by 2 list of 2D position on the unit circle for the vertices in b)igl_Qu8mg5v7";
  635. const char *__doc_igl_massmatrix = R"igl_Qu8mg5v7(// Constructs the mass (area) matrix for a given mesh (V,F).
  636. //
  637. // Templates:
  638. // DerivedV derived type of eigen matrix for V (e.g. derived from
  639. // MatrixXd)
  640. // DerivedF derived type of eigen matrix for F (e.g. derived from
  641. // MatrixXi)
  642. // Scalar scalar type for eigen sparse matrix (e.g. double)
  643. // Inputs:
  644. // V #V by dim list of mesh vertex positions
  645. // F #F by simplex_size list of mesh faces (must be triangles)
  646. // type one of the following ints:
  647. // MASSMATRIX_TYPE_BARYCENTRIC barycentric
  648. // MASSMATRIX_TYPE_VORONOI voronoi-hybrid {default}
  649. // MASSMATRIX_TYPE_FULL full {not implemented}
  650. // Outputs:
  651. // M #V by #V mass matrix
  652. //
  653. // See also: adjacency_matrix
  654. //)igl_Qu8mg5v7";
  655. const char *__doc_igl_min_quad_with_fixed_precompute = R"igl_Qu8mg5v7(// Known Bugs: rows of Aeq **should probably** be linearly independent.
  656. // During precomputation, the rows of a Aeq are checked via QR. But in case
  657. // they're not then resulting probably will no longer be sparse: it will be
  658. // slow.
  659. //
  660. // MIN_QUAD_WITH_FIXED Minimize quadratic energy
  661. //
  662. // 0.5*Z'*A*Z + Z'*B + C with
  663. //
  664. // constraints that Z(known) = Y, optionally also subject to the constraints
  665. // Aeq*Z = Beq
  666. //
  667. // Templates:
  668. // T should be a eigen matrix primitive type like int or double
  669. // Inputs:
  670. // A n by n matrix of quadratic coefficients
  671. // known list of indices to known rows in Z
  672. // Y list of fixed values corresponding to known rows in Z
  673. // Aeq m by n list of linear equality constraint coefficients
  674. // pd flag specifying whether A(unknown,unknown) is positive definite
  675. // Outputs:
  676. // data factorization struct with all necessary information to solve
  677. // using min_quad_with_fixed_solve
  678. // Returns true on success, false on error
  679. //
  680. // Benchmark: For a harmonic solve on a mesh with 325K facets, matlab 2.2
  681. // secs, igl/min_quad_with_fixed.h 7.1 secs
  682. //)igl_Qu8mg5v7";
  683. const char *__doc_igl_min_quad_with_fixed_solve = R"igl_Qu8mg5v7(// Solves a system previously factored using min_quad_with_fixed_precompute
  684. //
  685. // Template:
  686. // T type of sparse matrix (e.g. double)
  687. // DerivedY type of Y (e.g. derived from VectorXd or MatrixXd)
  688. // DerivedZ type of Z (e.g. derived from VectorXd or MatrixXd)
  689. // Inputs:
  690. // data factorization struct with all necessary precomputation to solve
  691. // B n by 1 column of linear coefficients
  692. // Y b by 1 list of constant fixed values
  693. // Beq m by 1 list of linear equality constraint constant values
  694. // Outputs:
  695. // Z n by cols solution
  696. // sol #unknowns+#lagrange by cols solution to linear system
  697. // Returns true on success, false on error)igl_Qu8mg5v7";
  698. const char *__doc_igl_min_quad_with_fixed = R"igl_Qu8mg5v7(See min_quad_with_fixed for the documentation.)igl_Qu8mg5v7";
  699. const char *__doc_igl_n_polyvector = R"igl_Qu8mg5v7(// Inputs:
  700. // v0, v1 the two #3 by 1 vectors
  701. // normalized boolean, if false, then the vectors are normalized prior to the calculation
  702. // Output:
  703. // 3 by 3 rotation matrix that takes v0 to v1
  704. //)igl_Qu8mg5v7";
  705. const char *__doc_igl_parula = R"igl_Qu8mg5v7(// PARULA like MATLAB's parula
  706. //
  707. // Inputs:
  708. // m number of colors
  709. // Outputs:
  710. // J m by list of RGB colors between 0 and 1
  711. //
  712. // Wrapper for directly computing [r,g,b] values for a given factor f between
  713. // 0 and 1
  714. //
  715. // Inputs:
  716. // f factor determining color value as if 0 was min and 1 was max
  717. // Outputs:
  718. // r red value
  719. // g green value
  720. // b blue value)igl_Qu8mg5v7";
  721. const char *__doc_igl_per_corner_normals = R"igl_Qu8mg5v7(// Compute vertex normals via vertex position list, face list
  722. // Inputs:
  723. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  724. // F #F by 3 eigne Matrix of face (triangle) indices
  725. // corner_threshold threshold in degrees on sharp angles
  726. // Output:
  727. // CN #F*3 by 3 eigen Matrix of mesh vertex 3D normals, where the normal
  728. // for corner F(i,j) is at CN(i*3+j,:) )igl_Qu8mg5v7";
  729. const char *__doc_igl_per_edge_normals = R"igl_Qu8mg5v7(// Compute face normals via vertex position list, face list
  730. // Inputs:
  731. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  732. // F #F by 3 eigen Matrix of face (triangle) indices
  733. // weight weighting type
  734. // FN #F by 3 matrix of 3D face normals per face
  735. // Output:
  736. // N #2 by 3 matrix of mesh edge 3D normals per row
  737. // E #E by 2 matrix of edge indices per row
  738. // EMAP #E by 1 matrix of indices from all edges to E
  739. //)igl_Qu8mg5v7";
  740. const char *__doc_igl_per_face_normals = R"igl_Qu8mg5v7(// Compute face normals via vertex position list, face list
  741. // Inputs:
  742. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  743. // F #F by 3 eigen Matrix of face (triangle) indices
  744. // Z 3 vector normal given to faces with degenerate normal.
  745. // Output:
  746. // N #F by 3 eigen Matrix of mesh face (triangle) 3D normals
  747. //
  748. // Example:
  749. // // Give degenerate faces (1/3,1/3,1/3)^0.5
  750. // per_face_normals(V,F,Vector3d(1,1,1).normalized(),N);)igl_Qu8mg5v7";
  751. const char *__doc_igl_per_face_normals_stable = R"igl_Qu8mg5v7(// Special version where order of face indices is guaranteed not to effect
  752. // output.)igl_Qu8mg5v7";
  753. const char *__doc_igl_per_vertex_normals = R"igl_Qu8mg5v7(// Compute vertex normals via vertex position list, face list
  754. // Inputs:
  755. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  756. // F #F by 3 eigne Matrix of face (triangle) indices
  757. // weighting Weighting type
  758. // Output:
  759. // N #V by 3 eigen Matrix of mesh vertex 3D normals)igl_Qu8mg5v7";
  760. const char *__doc_igl_planarize_quad_mesh = R"igl_Qu8mg5v7(// Inputs:
  761. // Vin #V by 3 eigen Matrix of mesh vertex 3D positions
  762. // F #F by 4 eigen Matrix of face (quad) indices
  763. // maxIter maximum numbers of iterations
  764. // threshold minimum allowed threshold for non-planarity
  765. // Output:
  766. // Vout #V by 3 eigen Matrix of planar mesh vertex 3D positions
  767. //)igl_Qu8mg5v7";
  768. const char *__doc_igl_png_readPNG = R"igl_Qu8mg5v7(// Read an image from a .png file into 4 memory buffers
  769. //
  770. // Input:
  771. // png_file path to .png file
  772. // Output:
  773. // R,G,B,A texture channels
  774. // Returns true on success, false on failure
  775. //)igl_Qu8mg5v7";
  776. const char *__doc_igl_png_writePNG = R"igl_Qu8mg5v7(// Writes an image to a png file
  777. //
  778. // Input:
  779. // R,G,B,A texture channels
  780. // Output:
  781. // png_file path to .png file
  782. // Returns true on success, false on failure
  783. //)igl_Qu8mg5v7";
  784. const char *__doc_igl_point_mesh_squared_distance = R"igl_Qu8mg5v7(// Compute distances from a set of points P to a triangle mesh (V,F)
  785. //
  786. // Inputs:
  787. // P #P by 3 list of query point positions
  788. // V #V by 3 list of vertex positions
  789. // Ele #Ele by (3|2|1) list of (triangle|edge|point) indices
  790. // Outputs:
  791. // sqrD #P list of smallest squared distances
  792. // I #P list of primitive indices corresponding to smallest distances
  793. // C #P by 3 list of closest points
  794. //
  795. // Known bugs: This only computes distances to given primitivess. So
  796. // unreferenced vertices are ignored. However, degenerate primitives are
  797. // handled correctly: triangle [1 2 2] is treated as a segment [1 2], and
  798. // triangle [1 1 1] is treated as a point. So one _could_ add extra
  799. // combinatorially degenerate rows to Ele for all unreferenced vertices to
  800. // also get distances to points.)igl_Qu8mg5v7";
  801. const char *__doc_igl_polar_svd = R"igl_Qu8mg5v7(// Computes the polar decomposition (R,T) of a matrix A using SVD singular
  802. // value decomposition
  803. //
  804. // Inputs:
  805. // A 3 by 3 matrix to be decomposed
  806. // Outputs:
  807. // R 3 by 3 rotation matrix part of decomposition (**always rotataion**)
  808. // T 3 by 3 stretch matrix part of decomposition
  809. // U 3 by 3 left-singular vectors
  810. // S 3 by 1 singular values
  811. // V 3 by 3 right-singular vectors
  812. //
  813. //)igl_Qu8mg5v7";
  814. const char *__doc_igl_principal_curvature = R"igl_Qu8mg5v7(// Compute the principal curvature directions and magnitude of the given triangle mesh
  815. // DerivedV derived from vertex positions matrix type: i.e. MatrixXd
  816. // DerivedF derived from face indices matrix type: i.e. MatrixXi
  817. // Inputs:
  818. // V eigen matrix #V by 3
  819. // F #F by 3 list of mesh faces (must be triangles)
  820. // radius controls the size of the neighbourhood used, 1 = average edge lenght
  821. //
  822. // Outputs:
  823. // PD1 #V by 3 maximal curvature direction for each vertex.
  824. // PD2 #V by 3 minimal curvature direction for each vertex.
  825. // PV1 #V by 1 maximal curvature value for each vertex.
  826. // PV2 #V by 1 minimal curvature value for each vertex.
  827. //
  828. // See also: average_onto_faces, average_onto_vertices
  829. //
  830. // This function has been developed by: Nikolas De Giorgis, Luigi Rocca and Enrico Puppo.
  831. // The algorithm is based on:
  832. // Efficient Multi-scale Curvature and Crease Estimation
  833. // Daniele Panozzo, Enrico Puppo, Luigi Rocca
  834. // GraVisMa, 2010)igl_Qu8mg5v7";
  835. const char *__doc_igl_quad_planarity = R"igl_Qu8mg5v7(// Compute planarity of the faces of a quad mesh
  836. // Inputs:
  837. // V #V by 3 eigen Matrix of mesh vertex 3D positions
  838. // F #F by 4 eigen Matrix of face (quad) indices
  839. // Output:
  840. // P #F by 1 eigen Matrix of mesh face (quad) planarities
  841. //)igl_Qu8mg5v7";
  842. const char *__doc_igl_randperm = R"igl_Qu8mg5v7(// Like matlab's randperm(n) but minus 1
  843. //
  844. // Inputs:
  845. // n number of elements
  846. // Outputs:
  847. // I n list of rand permutation of 0:n-1)igl_Qu8mg5v7";
  848. const char *__doc_igl_readDMAT = R"igl_Qu8mg5v7(See readDMAT for the documentation.)igl_Qu8mg5v7";
  849. const char *__doc_igl_readMESH = R"igl_Qu8mg5v7(// load a tetrahedral volume mesh from a .mesh file
  850. //
  851. // Templates:
  852. // Scalar type for positions and vectors (will be read as double and cast
  853. // to Scalar)
  854. // Index type for indices (will be read as int and cast to Index)
  855. // Input:
  856. // mesh_file_name path of .mesh file
  857. // Outputs:
  858. // V double matrix of vertex positions #V by 3
  859. // T #T list of tet indices into vertex positions
  860. // F #F list of face indices into vertex positions
  861. //
  862. // Known bugs: Holes and regions are not supported)igl_Qu8mg5v7";
  863. const char *__doc_igl_readOBJ = R"igl_Qu8mg5v7(// Read a mesh from an ascii obj file, filling in vertex positions, normals
  864. // and texture coordinates. Mesh may have faces of any number of degree
  865. //
  866. // Templates:
  867. // Scalar type for positions and vectors (will be read as double and cast
  868. // to Scalar)
  869. // Index type for indices (will be read as int and cast to Index)
  870. // Inputs:
  871. // str path to .obj file
  872. // Outputs:
  873. // V double matrix of vertex positions #V by 3
  874. // TC double matrix of texture coordinats #TC by 2
  875. // N double matrix of corner normals #N by 3
  876. // F #F list of face indices into vertex positions
  877. // FTC #F list of face indices into vertex texture coordinates
  878. // FN #F list of face indices into vertex normals
  879. // Returns true on success, false on errors)igl_Qu8mg5v7";
  880. const char *__doc_igl_readOFF = R"igl_Qu8mg5v7(// Read a mesh from an ascii obj file, filling in vertex positions, normals
  881. // and texture coordinates. Mesh may have faces of any number of degree
  882. //
  883. // Templates:
  884. // Scalar type for positions and vectors (will be read as double and cast
  885. // to Scalar)
  886. // Index type for indices (will be read as int and cast to Index)
  887. // Inputs:
  888. // str path to .obj file
  889. // Outputs:
  890. // V double matrix of vertex positions #V by 3
  891. // F #F list of face indices into vertex positions
  892. // TC double matrix of texture coordinats #TC by 2
  893. // FTC #F list of face indices into vertex texture coordinates
  894. // N double matrix of corner normals #N by 3
  895. // FN #F list of face indices into vertex normals
  896. // Returns true on success, false on errors)igl_Qu8mg5v7";
  897. const char *__doc_igl_read_triangle_mesh = R"igl_Qu8mg5v7(// read mesh from an ascii file with automatic detection of file format.
  898. // supported: obj, off, stl, wrl, ply, mesh)
  899. //
  900. // Templates:
  901. // Scalar type for positions and vectors (will be read as double and cast
  902. // to Scalar)
  903. // Index type for indices (will be read as int and cast to Index)
  904. // Inputs:
  905. // str path to file
  906. // Outputs:
  907. // V eigen double matrix #V by 3
  908. // F eigen int matrix #F by 3
  909. // Returns true iff success)igl_Qu8mg5v7";
  910. const char *__doc_igl_remove_duplicate_vertices = R"igl_Qu8mg5v7(// REMOVE_DUPLICATE_VERTICES Remove duplicate vertices upto a uniqueness
  911. // tolerance (epsilon)
  912. //
  913. // Inputs:
  914. // V #V by dim list of vertex positions
  915. // epsilon uniqueness tolerance (significant digit), can probably think of
  916. // this as a tolerance on L1 distance
  917. // Outputs:
  918. // SV #SV by dim new list of vertex positions
  919. // SVI #V by 1 list of indices so SV = V(SVI,:)
  920. // SVJ #SV by 1 list of indices so V = SV(SVJ,:)
  921. //
  922. // Example:
  923. // % Mesh in (V,F)
  924. // [SV,SVI,SVJ] = remove_duplicate_vertices(V,1e-7);
  925. // % remap faces
  926. // SF = SVJ(F);
  927. //)igl_Qu8mg5v7";
  928. const char *__doc_igl_rotate_vectors = R"igl_Qu8mg5v7(// Rotate the vectors V by A radiants on the tangent plane spanned by B1 and
  929. // B2
  930. //
  931. // Inputs:
  932. // V #V by 3 eigen Matrix of vectors
  933. // A #V eigen vector of rotation angles or a single angle to be applied
  934. // to all vectors
  935. // B1 #V by 3 eigen Matrix of base vector 1
  936. // B2 #V by 3 eigen Matrix of base vector 2
  937. //
  938. // Output:
  939. // Returns the rotated vectors
  940. //)igl_Qu8mg5v7";
  941. const char *__doc_igl_setdiff = R"igl_Qu8mg5v7(// Set difference of elements of matrices
  942. //
  943. // Inputs:
  944. // A m-long vector of indices
  945. // B n-long vector of indices
  946. // Outputs:
  947. // C (k<=m)-long vector of unique elements appearing in A but not in B
  948. // IA (k<=m)-long list of indices into A so that C = A(IA)
  949. //)igl_Qu8mg5v7";
  950. const char *__doc_igl_signed_distance = R"igl_Qu8mg5v7(// Computes signed distance to a mesh
  951. //
  952. // Inputs:
  953. // P #P by 3 list of query point positions
  954. // V #V by 3 list of vertex positions
  955. // F #F by ss list of triangle indices, ss should be 3 unless sign_type ==
  956. // SIGNED_DISTANCE_TYPE_UNSIGNED
  957. // sign_type method for computing distance _sign_ S
  958. // Outputs:
  959. // S #P list of smallest signed distances
  960. // I #P list of facet indices corresponding to smallest distances
  961. // C #P by 3 list of closest points
  962. // N #P by 3 list of closest normals (only set if
  963. // sign_type=SIGNED_DISTANCE_TYPE_PSEUDONORMAL)
  964. //
  965. // Known bugs: This only computes distances to triangles. So unreferenced
  966. // vertices and degenerate triangles are ignored.)igl_Qu8mg5v7";
  967. const char *__doc_igl_signed_distance_pseudonormal = R"igl_Qu8mg5v7(// Computes signed distance to mesh
  968. //
  969. // Inputs:
  970. // tree AABB acceleration tree (see AABB.h)
  971. // F #F by 3 list of triangle indices
  972. // FN #F by 3 list of triangle normals
  973. // VN #V by 3 list of vertex normals (ANGLE WEIGHTING)
  974. // EN #E by 3 list of edge normals (UNIFORM WEIGHTING)
  975. // EMAP #F*3 mapping edges in F to E
  976. // q Query point
  977. // Returns signed distance to mesh
  978. //)igl_Qu8mg5v7";
  979. const char *__doc_igl_signed_distance_winding_number = R"igl_Qu8mg5v7(// Inputs:
  980. // tree AABB acceleration tree (see cgal/point_mesh_squared_distance.h)
  981. // hier Winding number evaluation hierarchy
  982. // q Query point
  983. // Returns signed distance to mesh)igl_Qu8mg5v7";
  984. const char *__doc_igl_slice = R"igl_Qu8mg5v7(// Act like the matlab X(row_indices,col_indices) operator, where
  985. // row_indices, col_indices are non-negative integer indices.
  986. //
  987. // Inputs:
  988. // X m by n matrix
  989. // R list of row indices
  990. // C list of column indices
  991. // Output:
  992. // Y #R by #C matrix
  993. //
  994. // See also: slice_mask)igl_Qu8mg5v7";
  995. const char *__doc_igl_slice_into = R"igl_Qu8mg5v7(// Act like the matlab Y(row_indices,col_indices) = X
  996. //
  997. // Inputs:
  998. // X xm by xn rhs matrix
  999. // R list of row indices
  1000. // C list of column indices
  1001. // Y ym by yn lhs matrix
  1002. // Output:
  1003. // Y ym by yn lhs matrix, same as input but Y(R,C) = X)igl_Qu8mg5v7";
  1004. const char *__doc_igl_slice_mask = R"igl_Qu8mg5v7(// Act like the matlab X(row_mask,col_mask) operator, where
  1005. // row_mask, col_mask are non-negative integer indices.
  1006. //
  1007. // Inputs:
  1008. // X m by n matrix
  1009. // R m list of row bools
  1010. // C n list of column bools
  1011. // Output:
  1012. // Y #trues-in-R by #trues-in-C matrix
  1013. //
  1014. // See also: slice_mask)igl_Qu8mg5v7";
  1015. const char *__doc_igl_slice_tets = R"igl_Qu8mg5v7(// SLICE_TETS Slice through a tet mesh (V,T) along a given plane (via its
  1016. // implicit equation).
  1017. //
  1018. // Inputs:
  1019. // V #V by 3 list of tet mesh vertices
  1020. // T #T by 4 list of tet indices into V
  1021. // plane list of 4 coefficients in the plane equation: [x y z 1]'*plane = 0
  1022. // Optional:
  1023. // 'Manifold' followed by whether to stitch together triangles into a
  1024. // manifold mesh {true}: results in more compact U but slightly slower.
  1025. // Outputs:
  1026. // U #U by 3 list of triangle mesh vertices along slice
  1027. // G #G by 3 list of triangles indices into U
  1028. // J #G list of indices into T revealing from which tet each faces comes
  1029. // BC #U by #V list of barycentric coordinates (or more generally: linear
  1030. // interpolation coordinates) so that U = BC*V
  1031. // )igl_Qu8mg5v7";
  1032. const char *__doc_igl_sortrows = R"igl_Qu8mg5v7(// Act like matlab's [Y,I] = sortrows(X)
  1033. //
  1034. // Templates:
  1035. // DerivedX derived scalar type, e.g. MatrixXi or MatrixXd
  1036. // DerivedI derived integer type, e.g. MatrixXi
  1037. // Inputs:
  1038. // X m by n matrix whose entries are to be sorted
  1039. // ascending sort ascending (true, matlab default) or descending (false)
  1040. // Outputs:
  1041. // Y m by n matrix whose entries are sorted (**should not** be same
  1042. // reference as X)
  1043. // I m list of indices so that
  1044. // Y = X(I,:);)igl_Qu8mg5v7";
  1045. const char *__doc_igl_streamlines_init = R"igl_Qu8mg5v7(// Given a mesh and a field the function computes the /data/ necessary for tracing the field'
  1046. // streamlines, and creates the initial /state/ for the tracing.
  1047. // Inputs:
  1048. // V #V by 3 list of mesh vertex coordinates
  1049. // F #F by 3 list of mesh faces
  1050. // temp_field #F by 3n list of the 3D coordinates of the per-face vectors
  1051. // (n-degrees stacked horizontally for each triangle)
  1052. // treat_as_symmetric
  1053. // if true, adds n symmetry directions to the field (N = 2n). Else N = n
  1054. // percentage [0-1] percentage of faces sampled
  1055. // Outputs:
  1056. // data struct containing topology information of the mesh and field
  1057. // state struct containing the state of the tracing)igl_Qu8mg5v7";
  1058. const char *__doc_igl_streamlines_next = R"igl_Qu8mg5v7(// The function computes the next state for each point in the sample
  1059. // V #V by 3 list of mesh vertex coordinates
  1060. // F #F by 3 list of mesh faces
  1061. // data struct containing topology information
  1062. // state struct containing the state of the tracing)igl_Qu8mg5v7";
  1063. const char *__doc_igl_triangle_triangle_adjacency = R"igl_Qu8mg5v7(// Constructs the triangle-triangle adjacency matrix for a given
  1064. // mesh (V,F).
  1065. //
  1066. // Templates:
  1067. // Scalar derived type of eigen matrix for V (e.g. derived from
  1068. // MatrixXd)
  1069. // Index derived type of eigen matrix for F (e.g. derived from
  1070. // MatrixXi)
  1071. // Inputs:
  1072. // F #F by simplex_size list of mesh faces (must be triangles)
  1073. // Outputs:
  1074. // TT #F by #3 adjacent matrix, the element i,j is the id of the triangle adjacent to the j edge of triangle i
  1075. // TTi #F by #3 adjacent matrix, the element i,j is the id of edge of the triangle TT(i,j) that is adjacent with triangle i
  1076. // NOTE: the first edge of a triangle is [0,1] the second [1,2] and the third [2,3].
  1077. // this convention is DIFFERENT from cotmatrix_entries.h
  1078. // Known bug: this should not need to take V as input.)igl_Qu8mg5v7";
  1079. const char *__doc_igl_triangle_triangle_adjacency_preprocess = R"igl_Qu8mg5v7(// Preprocessing)igl_Qu8mg5v7";
  1080. const char *__doc_igl_triangle_triangle_adjacency_extractTT = R"igl_Qu8mg5v7(// Extract the face adjacencies)igl_Qu8mg5v7";
  1081. const char *__doc_igl_triangle_triangle_adjacency_extractTTi = R"igl_Qu8mg5v7(// Extract the face adjacencies indices (needed for fast traversal))igl_Qu8mg5v7";
  1082. const char *__doc_igl_triangle_triangulate = R"igl_Qu8mg5v7(// Triangulate the interior of a polygon using the triangle library.
  1083. //
  1084. // Inputs:
  1085. // V #V by 2 list of 2D vertex positions
  1086. // E #E by 2 list of vertex ids forming unoriented edges of the boundary of the polygon
  1087. // H #H by 2 coordinates of points contained inside holes of the polygon
  1088. // flags string of options pass to triangle (see triangle documentation)
  1089. // Outputs:
  1090. // V2 #V2 by 2 coordinates of the vertives of the generated triangulation
  1091. // F2 #F2 by 3 list of indices forming the faces of the generated triangulation
  1092. //
  1093. // TODO: expose the option to prevent Steiner points on the boundary
  1094. //)igl_Qu8mg5v7";
  1095. const char *__doc_igl_unique = R"igl_Qu8mg5v7(// Act like matlab's [C,IA,IC] = unique(X)
  1096. //
  1097. // Templates:
  1098. // T comparable type T
  1099. // Inputs:
  1100. // A #A vector of type T
  1101. // Outputs:
  1102. // C #C vector of unique entries in A
  1103. // IA #C index vector so that C = A(IA);
  1104. // IC #A index vector so that A = C(IC);)igl_Qu8mg5v7";
  1105. const char *__doc_igl_unique_rows = R"igl_Qu8mg5v7(// Act like matlab's [C,IA,IC] = unique(X,'rows')
  1106. //
  1107. // Templates:
  1108. // DerivedA derived scalar type, e.g. MatrixXi or MatrixXd
  1109. // DerivedIA derived integer type, e.g. MatrixXi
  1110. // DerivedIC derived integer type, e.g. MatrixXi
  1111. // Inputs:
  1112. // A m by n matrix whose entries are to unique'd according to rows
  1113. // Outputs:
  1114. // C #C vector of unique rows in A
  1115. // IA #C index vector so that C = A(IA,:);
  1116. // IC #A index vector so that A = C(IC,:);)igl_Qu8mg5v7";
  1117. const char *__doc_igl_unproject_onto_mesh = R"igl_Qu8mg5v7(// Unproject a screen location (using current opengl viewport, projection, and
  1118. // model view) to a 3D position _onto_ a given mesh, if the ray through the
  1119. // given screen location (x,y) _hits_ the mesh.
  1120. //
  1121. // Inputs:
  1122. // pos screen space coordinates
  1123. // model model matrix
  1124. // proj projection matrix
  1125. // viewport vieweport vector
  1126. // V #V by 3 list of mesh vertex positions
  1127. // F #F by 3 list of mesh triangle indices into V
  1128. // Outputs:
  1129. // fid id of the first face hit
  1130. // bc barycentric coordinates of hit
  1131. // Returns true if there's a hit)igl_Qu8mg5v7";
  1132. const char *__doc_igl_upsample = R"igl_Qu8mg5v7(// Subdivide a mesh without moving vertices: loop subdivision but odd
  1133. // vertices stay put and even vertices are just edge midpoints
  1134. //
  1135. // Templates:
  1136. // MatV matrix for vertex positions, e.g. MatrixXd
  1137. // MatF matrix for vertex positions, e.g. MatrixXi
  1138. // Inputs:
  1139. // V #V by dim mesh vertices
  1140. // F #F by 3 mesh triangles
  1141. // Outputs:
  1142. // NV new vertex positions, V is guaranteed to be at top
  1143. // NF new list of face indices
  1144. //
  1145. // NOTE: V should not be the same as NV,
  1146. // NOTE: F should not be the same as NF, use other proto
  1147. //
  1148. // Known issues:
  1149. // - assumes (V,F) is edge-manifold.)igl_Qu8mg5v7";
  1150. const char *__doc_igl_winding_number = R"igl_Qu8mg5v7(// WINDING_NUMBER Compute the sum of solid angles of a triangle/tetrahedron
  1151. // described by points (vectors) V
  1152. //
  1153. // Templates:
  1154. // dim dimension of input
  1155. // Inputs:
  1156. // V n by 3 list of vertex positions
  1157. // F #F by 3 list of triangle indices, minimum index is 0
  1158. // O no by 3 list of origin positions
  1159. // Outputs:
  1160. // S no by 1 list of winding numbers
  1161. //
  1162. // 3d)igl_Qu8mg5v7";
  1163. const char *__doc_igl_winding_number_3 = R"igl_Qu8mg5v7(// Inputs:
  1164. // V pointer to array containing #V by 3 vertex positions along rows,
  1165. // given in column major order
  1166. // n number of mesh vertices
  1167. // F pointer to array containing #F by 3 face indices along rows,
  1168. // given in column major order
  1169. // m number of faces
  1170. // O pointer to array containing #O by 3 query positions along rows,
  1171. // given in column major order
  1172. // no number of origins
  1173. // Outputs:
  1174. // S no by 1 list of winding numbers)igl_Qu8mg5v7";
  1175. const char *__doc_igl_winding_number_2 = R"igl_Qu8mg5v7(//// Only one evaluation origin
  1176. //template <typename DerivedF>
  1177. //IGL_INLINE void winding_number_3(
  1178. // const double * V,
  1179. // const int n,
  1180. // const DerivedF * F,
  1181. // const int m,
  1182. // const double * O,
  1183. // double * S);
  1184. // 2d)igl_Qu8mg5v7";
  1185. const char *__doc_igl_writeMESH = R"igl_Qu8mg5v7(// save a tetrahedral volume mesh to a .mesh file
  1186. //
  1187. // Templates:
  1188. // Scalar type for positions and vectors (will be cast as double)
  1189. // Index type for indices (will be cast to int)
  1190. // Input:
  1191. // mesh_file_name path of .mesh file
  1192. // V double matrix of vertex positions #V by 3
  1193. // T #T list of tet indices into vertex positions
  1194. // F #F list of face indices into vertex positions
  1195. //
  1196. // Known bugs: Holes and regions are not supported)igl_Qu8mg5v7";
  1197. const char *__doc_igl_writeOBJ = R"igl_Qu8mg5v7(// Write a mesh in an ascii obj file
  1198. // Inputs:
  1199. // str path to outputfile
  1200. // V #V by 3 mesh vertex positions
  1201. // F #F by 3|4 mesh indices into V
  1202. // CN #CN by 3 normal vectors
  1203. // FN #F by 3|4 corner normal indices into CN
  1204. // TC #TC by 2|3 texture coordinates
  1205. // FTC #F by 3|4 corner texture coord indices into TC
  1206. // Returns true on success, false on error)igl_Qu8mg5v7";