Skip to content

Commit

Permalink
Removed unnecessary code
Browse files Browse the repository at this point in the history
  • Loading branch information
Chonnik committed Mar 23, 2023
1 parent 19ca34b commit 267e25e
Show file tree
Hide file tree
Showing 14 changed files with 1 addition and 58 deletions.
1 change: 0 additions & 1 deletion src/HarmonicBase3D2D/HarmonicPolygon.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,6 @@
#include <fstream>
#include "GaussQuadrature.h"
#include "pmp/SurfaceMesh.h"
#include "pmp/algorithms/Triangulation.h"
#include "../Surface/diffgeo.h"

Eigen::Vector3d HarmonicPolygon::getScaledNormal() const {
Expand Down
2 changes: 0 additions & 2 deletions src/HarmonicBase3D2D/HarmonicPolygon.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -4,8 +4,6 @@
#include <Eigen/Dense>
#include <vector>



class HarmonicPolygon {

int n = 0;
Expand Down
16 changes: 0 additions & 16 deletions src/Surface/GeodesicsInHeat.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -266,22 +266,6 @@ void GeodesicsInHeat::distance_to_texture_coordinates() const {
auto distances = mesh_.get_vertex_property<Scalar>("v:dist");
assert(distances);

// // scale with boundingbox size for comparable geodesic rings
// Scalar bb_size;
// bb_size = mesh_.bounds().size();
// auto tex = mesh_.vertex_property<TexCoord>("v:tex");
// for (auto v : mesh_.vertices())
// {
// if (distances[v] <= FLT_MAX)
// {
// tex[v] = TexCoord(distances[v] / bb_size, 0.0);
// }
// else
// {
// tex[v] = TexCoord(1.0, 0.0);
// }
// }

// find maximum distance
Scalar maxdist(0);
for (auto v: mesh_.vertices()) {
Expand Down
1 change: 0 additions & 1 deletion src/Surface/LaplaceConstruction.h
Original file line number Diff line number Diff line change
Expand Up @@ -8,7 +8,6 @@
#include <pmp/algorithms/DifferentialGeometry.h>
#include <pmp/algorithms/Triangulation.h>
#include <unsupported/Eigen/NonLinearOptimization>

//=============================================================================

using namespace pmp;
Expand Down
5 changes: 0 additions & 5 deletions src/Surface/Poisson_System.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -94,11 +94,6 @@ double solve_poisson_system(pmp::SurfaceMesh &mesh, int laplace, int minpoint,
}
solver.analyzePattern(M);
solver.factorize(M);
// Astrid
// analytic_solution.normalize();
// Fernando
// analytic_solution /= sqrt(analytic_solution.transpose() * M * analytic_solution);

X = solver.solve(S * analytic_solution);
if (solver.info() != Eigen::Success) {
std::cout << "Issue: " << solver.info() << std::endl;
Expand Down
2 changes: 0 additions & 2 deletions src/Surface/SpectralProcessing.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -107,8 +107,6 @@ double solve_eigenvalue_problem(SurfaceMesh &mesh, int laplace, int face_point,
analytic_eigenvalues_unitsphere(analytic, num_eval);

for (int i = 1; i < evalues.size(); i++) {
// std::cout << evalues(i) << "," << analytic(i) << ","
// << evalues(i) - analytic(i) << std::endl;
ev_file << evalues(i) << "," << analytic(i) << ","
<< evalues(i) - analytic(i) << std::endl;
error += pow(evalues(i) - analytic(i), 2);
Expand Down
3 changes: 0 additions & 3 deletions src/SurfaceViewer.h
Original file line number Diff line number Diff line change
@@ -1,7 +1,4 @@
//=============================================================================
// Copyright 2021 Astrid Bunge, Mario Botsch, Marc Alexa.
// Distributed under MIT license, see file LICENSE for details.
//=============================================================================
#pragma once
//=============================================================================

Expand Down
5 changes: 0 additions & 5 deletions src/Volume/Diamond_3D.cpp
Original file line number Diff line number Diff line change
@@ -1,12 +1,7 @@
//=============================================================================
// Copyright 2021 Astrid Bunge, Mario Botsch, Marc Alexa.
// Distributed under MIT license, see file LICENSE for details.
//=============================================================================

#include "Diamond_3D.h"
#include <pmp/MatVec.h>
#include "diffgeo_3D.h"

//=============================================================================

using SparseMatrix = Eigen::SparseMatrix<double>;
Expand Down
3 changes: 0 additions & 3 deletions src/Volume/Diamond_3D.h
Original file line number Diff line number Diff line change
@@ -1,7 +1,4 @@
//=============================================================================
// Copyright 2021 Astrid Bunge, Mario Botsch, Marc Alexa.
// Distributed under MIT license, see file LICENSE for details.
//=============================================================================
#pragma once
//=============================================================================

Expand Down
9 changes: 1 addition & 8 deletions src/Volume/HarmonicBasis.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -144,9 +144,6 @@ void setup_3D_harmonic_stiffness_matrix(PolyhedralMesh &mesh, Eigen::SparseMatri
vector<vector<int>> faces;
allCellVertices[i] = mesh.getCellGeometry(i, vertices, faces);
harmonicPolyhedra[i] = HarmonicPolyhedron(vertices, faces);

// if(i % 10 == 0) std::cout << i << " / " << nc << std::endl;

}, nc);

// cannot parallelize quadrature initialization because tetgen seems to be not thread safe
Expand All @@ -155,9 +152,7 @@ void setup_3D_harmonic_stiffness_matrix(PolyhedralMesh &mesh, Eigen::SparseMatri
threadHelper<6>([&](const int i){

harmonicPolyhedra[i].stiffnessMatrix(allK[i]);
// harmonicPolyhedra[i].massMatrix(allM[i]);
// if(i % 10 == 0) std::cout << i << " / " << nc << std::endl;
//

}, nc);

vector<Eigen::Triplet<double>> tripK;
Expand Down Expand Up @@ -277,7 +272,6 @@ double setup_3D_harmonic_stiffness_matrix(PolyhedralMesh &mesh, Eigen::SparseMat
time += t.elapsed();
file << t.elapsed() << ",";
t.start();
// std::cout << "Basis construction << t.elapsed() <<
// cannot parallelize quadrature initialization because tetgen seems to be not thread safe
for(int i = 0; i < nc; ++i) harmonicPolyhedra[i].initQuadrature();
t.stop();
Expand All @@ -287,7 +281,6 @@ double setup_3D_harmonic_stiffness_matrix(PolyhedralMesh &mesh, Eigen::SparseMat
threadHelper<8>([&](const int i){

harmonicPolyhedra[i].stiffnessMatrix(allK[i]);
// if(i % 10 == 0) std::cout << i << " / " << nc << std::endl;

}, nc);

Expand Down
3 changes: 0 additions & 3 deletions src/Volume/diffgeo_3D.h
Original file line number Diff line number Diff line change
@@ -1,7 +1,4 @@
//=============================================================================
// Copyright 2021 Astrid Bunge, Mario Botsch, Marc Alexa.
// Distributed under MIT license, see file LICENSE for details.
//=============================================================================
#pragma once
//=============================================================================
#include <iostream>
Expand Down
3 changes: 0 additions & 3 deletions src/VolumeViewer.cpp
Original file line number Diff line number Diff line change
@@ -1,7 +1,4 @@
//=============================================================================
// Copyright 2021 Astrid Bunge, Mario Botsch, Marc Alexa.
// Distributed under MIT license, see file LICENSE for details.
//=============================================================================

#include <imgui.h>
#include <VolumeSubdivision.h>
Expand Down
3 changes: 0 additions & 3 deletions src/VolumeViewer.h
Original file line number Diff line number Diff line change
@@ -1,7 +1,4 @@
//=============================================================================
// Copyright 2021 Astrid Bunge, Mario Botsch, Marc Alexa.
// Distributed under MIT license, see file LICENSE for details.
//=============================================================================
#pragma once
//=============================================================================

Expand Down
3 changes: 0 additions & 3 deletions src/main.cpp
Original file line number Diff line number Diff line change
@@ -1,7 +1,4 @@
//=============================================================================
// Copyright 2021 Astrid Bunge, Mario Botsch, Marc Alexa.
// Distributed under MIT license, see file LICENSE for details.
//=============================================================================

#include "SurfaceViewer.h"
#include "VolumeViewer.h"
Expand Down

0 comments on commit 267e25e

Please sign in to comment.