Browse Source

Add missing IGL_INLINE in scaf.cpp (#1494)

Kobi1997 5 years ago
parent
commit
04457f1eae
1 changed files with 17 additions and 17 deletions
  1. 17 17
      include/igl/scaf.cpp

+ 17 - 17
include/igl/scaf.cpp

@@ -1,7 +1,7 @@
 // This file is part of libigl, a simple c++ geometry processing library.
 //
 // Copyright (C) 2018 Zhongshi Jiang <[email protected]>
-//
+// 
 // This Source Code Form is subject to the terms of the Mozilla Public License
 // v. 2.0. If a copy of the MPL was not distributed with this file, You can
 // obtain one at http://mozilla.org/MPL/2.0/.
@@ -41,7 +41,7 @@ namespace igl
 
 namespace scaf
 {
-void update_scaffold(igl::SCAFData &s)
+IGL_INLINE void update_scaffold(igl::SCAFData &s)
 {
   s.mv_num = s.m_V.rows();
   s.mf_num = s.m_T.rows();
@@ -55,7 +55,7 @@ void update_scaffold(igl::SCAFData &s)
   s.s_M = Eigen::VectorXd::Constant(s.sf_num, s.scaffold_factor);
 }
 
-void adjusted_grad(Eigen::MatrixXd &V,
+IGL_INLINE void adjusted_grad(Eigen::MatrixXd &V,
                    Eigen::MatrixXi &F,
                    double area_threshold,
                    Eigen::SparseMatrix<double> &Dx,
@@ -94,7 +94,7 @@ void adjusted_grad(Eigen::MatrixXd &V,
     }
 }
 
-void compute_scaffold_gradient_matrix(SCAFData &s,
+IGL_INLINE void compute_scaffold_gradient_matrix(SCAFData &s,
                                       Eigen::SparseMatrix<double> &D1,
                                       Eigen::SparseMatrix<double> &D2)
 {
@@ -137,7 +137,7 @@ void compute_scaffold_gradient_matrix(SCAFData &s,
        F2.col(2).asDiagonal() * Dz;
 }
 
-void mesh_improve(igl::SCAFData &s)
+IGL_INLINE void mesh_improve(igl::SCAFData &s)
 {
   using namespace Eigen;
   MatrixXd m_uv = s.w_uv.topRows(s.mv_num);
@@ -245,7 +245,7 @@ void mesh_improve(igl::SCAFData &s)
   s.W_s.resize(s.Dx_s.rows(), s.dim * s.dim);
 }
 
-void add_new_patch(igl::SCAFData &s, const Eigen::MatrixXd &V_ref,
+IGL_INLINE void add_new_patch(igl::SCAFData &s, const Eigen::MatrixXd &V_ref,
                    const Eigen::MatrixXi &F_ref,
                    const Eigen::RowVectorXd &center,
                    const Eigen::MatrixXd &uv_init)
@@ -293,7 +293,7 @@ void add_new_patch(igl::SCAFData &s, const Eigen::MatrixXd &V_ref,
   mesh_improve(s);
 }
 
-void compute_jacobians(SCAFData &s, const Eigen::MatrixXd &V_new, bool whole)
+IGL_INLINE void compute_jacobians(SCAFData &s, const Eigen::MatrixXd &V_new, bool whole)
 {
   auto comp_J2 = [](const Eigen::MatrixXd &uv,
                     const Eigen::SparseMatrix<double> &Dx,
@@ -313,7 +313,7 @@ void compute_jacobians(SCAFData &s, const Eigen::MatrixXd &V_new, bool whole)
     comp_J2(V_new, s.Dx_s, s.Dy_s, s.Ji_s);
 }
 
-double compute_energy_from_jacobians(const Eigen::MatrixXd &Ji,
+IGL_INLINE double compute_energy_from_jacobians(const Eigen::MatrixXd &Ji,
                                      const Eigen::VectorXd &areas,
                                      igl::MappingEnergyType energy_type)
 {
@@ -323,7 +323,7 @@ double compute_energy_from_jacobians(const Eigen::MatrixXd &Ji,
   return energy + igl::mapping_energy_with_jacobians(Ji, areas, energy_type, 0);
 }
 
-double compute_soft_constraint_energy(const SCAFData &s)
+IGL_INLINE double compute_soft_constraint_energy(const SCAFData &s)
 {
   double e = 0;
   for (auto const &x : s.soft_cons)
@@ -332,7 +332,7 @@ double compute_soft_constraint_energy(const SCAFData &s)
   return e;
 }
 
-double compute_energy(SCAFData &s, Eigen::MatrixXd &w_uv, bool whole)
+IGL_INLINE double compute_energy(SCAFData &s, Eigen::MatrixXd &w_uv, bool whole)
 {
   if (w_uv.rows() != s.v_num)
     assert(!whole);
@@ -345,7 +345,7 @@ double compute_energy(SCAFData &s, Eigen::MatrixXd &w_uv, bool whole)
   return energy;
 }
 
-void buildAm(const Eigen::VectorXd &sqrt_M,
+IGL_INLINE void buildAm(const Eigen::VectorXd &sqrt_M,
              const Eigen::SparseMatrix<double> &Dx,
              const Eigen::SparseMatrix<double> &Dy,
              const Eigen::MatrixXd &W,
@@ -362,7 +362,7 @@ void buildAm(const Eigen::VectorXd &sqrt_M,
   Am.makeCompressed();
 }
 
-void buildRhs(const Eigen::VectorXd &sqrt_M,
+IGL_INLINE void buildRhs(const Eigen::VectorXd &sqrt_M,
               const Eigen::MatrixXd &W,
               const Eigen::MatrixXd &Ri,
               Eigen::VectorXd &f_rhs)
@@ -381,7 +381,7 @@ void buildRhs(const Eigen::VectorXd &sqrt_M,
   }
 }
 
-void get_complement(const Eigen::VectorXi &bnd_ids, int v_n, Eigen::ArrayXi &unknown_ids)
+IGL_INLINE void get_complement(const Eigen::VectorXi &bnd_ids, int v_n, Eigen::ArrayXi &unknown_ids)
 { // get the complement of bnd_ids.
   int assign = 0, i = 0;
   for (int get = 0; i < v_n && get < bnd_ids.size(); i++)
@@ -396,7 +396,7 @@ void get_complement(const Eigen::VectorXi &bnd_ids, int v_n, Eigen::ArrayXi &unk
   assert(assign + bnd_ids.size() == v_n);
 }
 
-void build_surface_linear_system(const SCAFData &s, Eigen::SparseMatrix<double> &L, Eigen::VectorXd &rhs)
+IGL_INLINE void build_surface_linear_system(const SCAFData &s, Eigen::SparseMatrix<double> &L, Eigen::VectorXd &rhs)
 {
   using namespace Eigen;
   using namespace std;
@@ -477,7 +477,7 @@ void build_surface_linear_system(const SCAFData &s, Eigen::SparseMatrix<double>
   }
 }
 
-void build_scaffold_linear_system(const SCAFData &s, Eigen::SparseMatrix<double> &L, Eigen::VectorXd &rhs)
+IGL_INLINE void build_scaffold_linear_system(const SCAFData &s, Eigen::SparseMatrix<double> &L, Eigen::VectorXd &rhs)
 {
   using namespace Eigen;
 
@@ -529,7 +529,7 @@ void build_scaffold_linear_system(const SCAFData &s, Eigen::SparseMatrix<double>
   rhs = Aut * (frhs - Ae * known_pos);
 }
 
-void solve_weighted_arap(SCAFData &s, Eigen::MatrixXd &uv)
+IGL_INLINE void solve_weighted_arap(SCAFData &s, Eigen::MatrixXd &uv)
 {
   using namespace Eigen;
   using namespace std;
@@ -594,7 +594,7 @@ void solve_weighted_arap(SCAFData &s, Eigen::MatrixXd &uv)
   uv = Map<Matrix<double, -1, -1, Eigen::ColMajor>>(Uc.data(), v_n, dim);
 }
 
-double perform_iteration(SCAFData &s)
+IGL_INLINE double perform_iteration(SCAFData &s)
 {
   Eigen::MatrixXd V_out = s.w_uv;
   compute_jacobians(s, V_out, true);