diff --git a/include/DirectSolver/DirectSolver-COO-MUMPS-Give/directSolverGive.h b/include/DirectSolver/DirectSolver-COO-MUMPS-Give/directSolverGive.h index 1aacd097..168a6eb7 100644 --- a/include/DirectSolver/DirectSolver-COO-MUMPS-Give/directSolverGive.h +++ b/include/DirectSolver/DirectSolver-COO-MUMPS-Give/directSolverGive.h @@ -7,15 +7,15 @@ #include "dmumps_c.h" #include "mpi.h" -class DirectSolverGive : public DirectSolver +class DirectSolver_COO_MUMPS_Give : public DirectSolver { public: - explicit DirectSolverGive(const PolarGrid& grid, const LevelCache& level_cache, - const DomainGeometry& domain_geometry, - const DensityProfileCoefficients& density_profile_coefficients, bool DirBC_Interior, - int num_omp_threads); + explicit DirectSolver_COO_MUMPS_Give(const PolarGrid& grid, const LevelCache& level_cache, + const DomainGeometry& domain_geometry, + const DensityProfileCoefficients& density_profile_coefficients, + bool DirBC_Interior, int num_omp_threads); - ~DirectSolverGive() override; + ~DirectSolver_COO_MUMPS_Give() override; // Note: The rhs (right-hand side) vector gets overwritten during the solution process. void solveInPlace(Vector solution) override; diff --git a/include/DirectSolver/DirectSolver-COO-MUMPS-Take/directSolverTake.h b/include/DirectSolver/DirectSolver-COO-MUMPS-Take/directSolverTake.h index 123ce169..f497d19d 100644 --- a/include/DirectSolver/DirectSolver-COO-MUMPS-Take/directSolverTake.h +++ b/include/DirectSolver/DirectSolver-COO-MUMPS-Take/directSolverTake.h @@ -7,15 +7,15 @@ #include "dmumps_c.h" #include "mpi.h" -class DirectSolverTake : public DirectSolver +class DirectSolver_COO_MUMPS_Take : public DirectSolver { public: - explicit DirectSolverTake(const PolarGrid& grid, const LevelCache& level_cache, - const DomainGeometry& domain_geometry, - const DensityProfileCoefficients& density_profile_coefficients, bool DirBC_Interior, - int num_omp_threads); + explicit DirectSolver_COO_MUMPS_Take(const PolarGrid& grid, const LevelCache& level_cache, + const DomainGeometry& domain_geometry, + const DensityProfileCoefficients& density_profile_coefficients, + bool DirBC_Interior, int num_omp_threads); - ~DirectSolverTake() override; + ~DirectSolver_COO_MUMPS_Take() override; // Note: The rhs (right-hand side) vector gets overwritten during the solution process. void solveInPlace(Vector solution) override; diff --git a/include/DirectSolver/DirectSolver-CSR-LU-Give/directSolverGiveCustomLU.h b/include/DirectSolver/DirectSolver-CSR-LU-Give/directSolverGiveCustomLU.h index 6c2c61a2..bf4100c8 100644 --- a/include/DirectSolver/DirectSolver-CSR-LU-Give/directSolverGiveCustomLU.h +++ b/include/DirectSolver/DirectSolver-CSR-LU-Give/directSolverGiveCustomLU.h @@ -3,15 +3,15 @@ #include "../directSolver.h" #include -class DirectSolverGiveCustomLU : public DirectSolver +class DirectSolver_CSR_LU_Give : public DirectSolver { public: - explicit DirectSolverGiveCustomLU(const PolarGrid& grid, const LevelCache& level_cache, + explicit DirectSolver_CSR_LU_Give(const PolarGrid& grid, const LevelCache& level_cache, const DomainGeometry& domain_geometry, const DensityProfileCoefficients& density_profile_coefficients, bool DirBC_Interior, int num_omp_threads); - ~DirectSolverGiveCustomLU() override; + ~DirectSolver_CSR_LU_Give() override; // Note: The rhs (right-hand side) vector gets overwritten with the solution. void solveInPlace(Vector solution) override; diff --git a/include/DirectSolver/DirectSolver-CSR-LU-Take/directSolverTakeCustomLU.h b/include/DirectSolver/DirectSolver-CSR-LU-Take/directSolverTakeCustomLU.h index ae19b2a4..b194323f 100644 --- a/include/DirectSolver/DirectSolver-CSR-LU-Take/directSolverTakeCustomLU.h +++ b/include/DirectSolver/DirectSolver-CSR-LU-Take/directSolverTakeCustomLU.h @@ -2,15 +2,15 @@ #include "../directSolver.h" -class DirectSolverTakeCustomLU : public DirectSolver +class DirectSolver_CSR_LU_Take : public DirectSolver { public: - explicit DirectSolverTakeCustomLU(const PolarGrid& grid, const LevelCache& level_cache, + explicit DirectSolver_CSR_LU_Take(const PolarGrid& grid, const LevelCache& level_cache, const DomainGeometry& domain_geometry, const DensityProfileCoefficients& density_profile_coefficients, bool DirBC_Interior, int num_omp_threads); - ~DirectSolverTakeCustomLU() override; + ~DirectSolver_CSR_LU_Take() override; // Note: The rhs (right-hand side) vector gets overwritten with the solution. void solveInPlace(Vector solution) override; diff --git a/src/DirectSolver/DirectSolver-COO-MUMPS-Give/applySymmetryShift.cpp b/src/DirectSolver/DirectSolver-COO-MUMPS-Give/applySymmetryShift.cpp index 320657ab..812f7964 100644 --- a/src/DirectSolver/DirectSolver-COO-MUMPS-Give/applySymmetryShift.cpp +++ b/src/DirectSolver/DirectSolver-COO-MUMPS-Give/applySymmetryShift.cpp @@ -10,7 +10,7 @@ /* Boundary Symmetry Shift */ /* ----------------------- */ -void DirectSolverGive::applySymmetryShiftInnerBoundary(Vector x) const +void DirectSolver_COO_MUMPS_Give::applySymmetryShiftInnerBoundary(Vector x) const { assert(DirBC_Interior_); @@ -67,7 +67,7 @@ void DirectSolverGive::applySymmetryShiftInnerBoundary(Vector x) const } } -void DirectSolverGive::applySymmetryShiftOuterBoundary(Vector x) const +void DirectSolver_COO_MUMPS_Give::applySymmetryShiftOuterBoundary(Vector x) const { int i_r; double r; @@ -123,7 +123,7 @@ void DirectSolverGive::applySymmetryShiftOuterBoundary(Vector x) const } // clang-format off -void DirectSolverGive::applySymmetryShift(Vector x) const +void DirectSolver_COO_MUMPS_Give::applySymmetryShift(Vector x) const { assert(std::ssize(x) == grid_.numberOfNodes()); assert(grid_.nr() >= 4); diff --git a/src/DirectSolver/DirectSolver-COO-MUMPS-Give/buildSolverMatrix.cpp b/src/DirectSolver/DirectSolver-COO-MUMPS-Give/buildSolverMatrix.cpp index 055b47dc..63b8ce3b 100644 --- a/src/DirectSolver/DirectSolver-COO-MUMPS-Give/buildSolverMatrix.cpp +++ b/src/DirectSolver/DirectSolver-COO-MUMPS-Give/buildSolverMatrix.cpp @@ -765,7 +765,7 @@ } \ } while (0) -void DirectSolverGive::buildSolverMatrixCircleSection(const int i_r, SparseMatrixCOO& solver_matrix) +void DirectSolver_COO_MUMPS_Give::buildSolverMatrixCircleSection(const int i_r, SparseMatrixCOO& solver_matrix) { const double r = grid_.radius(i_r); for (int i_theta = 0; i_theta < grid_.ntheta(); i_theta++) { @@ -781,7 +781,8 @@ void DirectSolverGive::buildSolverMatrixCircleSection(const int i_r, SparseMatri } } -void DirectSolverGive::buildSolverMatrixRadialSection(const int i_theta, SparseMatrixCOO& solver_matrix) +void DirectSolver_COO_MUMPS_Give::buildSolverMatrixRadialSection(const int i_theta, + SparseMatrixCOO& solver_matrix) { const double theta = grid_.theta(i_theta); for (int i_r = grid_.numberSmootherCircles(); i_r < grid_.nr(); i_r++) { @@ -801,7 +802,7 @@ void DirectSolverGive::buildSolverMatrixRadialSection(const int i_theta, SparseM /* ------------------------------------------------------------------------ */ /* If the indexing is not smoother-based, please adjust the access patterns */ -SparseMatrixCOO DirectSolverGive::buildSolverMatrix() +SparseMatrixCOO DirectSolver_COO_MUMPS_Give::buildSolverMatrix() { const int n = grid_.numberOfNodes(); const int nnz = getNonZeroCountSolverMatrix(); diff --git a/src/DirectSolver/DirectSolver-COO-MUMPS-Give/directSolverGive.cpp b/src/DirectSolver/DirectSolver-COO-MUMPS-Give/directSolverGive.cpp index 1da58ee0..0a3e025c 100644 --- a/src/DirectSolver/DirectSolver-COO-MUMPS-Give/directSolverGive.cpp +++ b/src/DirectSolver/DirectSolver-COO-MUMPS-Give/directSolverGive.cpp @@ -2,17 +2,17 @@ #ifdef GMGPOLAR_USE_MUMPS -DirectSolverGive::DirectSolverGive(const PolarGrid& grid, const LevelCache& level_cache, - const DomainGeometry& domain_geometry, - const DensityProfileCoefficients& density_profile_coefficients, bool DirBC_Interior, - int num_omp_threads) +DirectSolver_COO_MUMPS_Give::DirectSolver_COO_MUMPS_Give(const PolarGrid& grid, const LevelCache& level_cache, + const DomainGeometry& domain_geometry, + const DensityProfileCoefficients& density_profile_coefficients, + bool DirBC_Interior, int num_omp_threads) : DirectSolver(grid, level_cache, domain_geometry, density_profile_coefficients, DirBC_Interior, num_omp_threads) { solver_matrix_ = buildSolverMatrix(); initializeMumpsSolver(mumps_solver_, solver_matrix_); } -void DirectSolverGive::solveInPlace(Vector solution) +void DirectSolver_COO_MUMPS_Give::solveInPlace(Vector solution) { // Adjusts the right-hand side vector to account for symmetry corrections. // This transforms the system matrixA * solution = rhs into the equivalent system: @@ -24,7 +24,7 @@ void DirectSolverGive::solveInPlace(Vector solution) solveWithMumps(solution); } -DirectSolverGive::~DirectSolverGive() +DirectSolver_COO_MUMPS_Give::~DirectSolver_COO_MUMPS_Give() { finalizeMumpsSolver(mumps_solver_); } diff --git a/src/DirectSolver/DirectSolver-COO-MUMPS-Give/initializeMumps.cpp b/src/DirectSolver/DirectSolver-COO-MUMPS-Give/initializeMumps.cpp index 881ced38..32ab52bf 100644 --- a/src/DirectSolver/DirectSolver-COO-MUMPS-Give/initializeMumps.cpp +++ b/src/DirectSolver/DirectSolver-COO-MUMPS-Give/initializeMumps.cpp @@ -2,7 +2,8 @@ #ifdef GMGPOLAR_USE_MUMPS -void DirectSolverGive::initializeMumpsSolver(DMUMPS_STRUC_C& mumps_solver, SparseMatrixCOO& solver_matrix) +void DirectSolver_COO_MUMPS_Give::initializeMumpsSolver(DMUMPS_STRUC_C& mumps_solver, + SparseMatrixCOO& solver_matrix) { /* * MUMPS (a parallel direct solver) uses 1-based indexing, @@ -102,7 +103,7 @@ void DirectSolverGive::initializeMumpsSolver(DMUMPS_STRUC_C& mumps_solver, Spars } } -void DirectSolverGive::solveWithMumps(Vector result_rhs) +void DirectSolver_COO_MUMPS_Give::solveWithMumps(Vector result_rhs) { mumps_solver_.job = JOB_COMPUTE_SOLUTION; mumps_solver_.nrhs = 1; @@ -115,7 +116,7 @@ void DirectSolverGive::solveWithMumps(Vector result_rhs) } } -void DirectSolverGive::finalizeMumpsSolver(DMUMPS_STRUC_C& mumps_solver) +void DirectSolver_COO_MUMPS_Give::finalizeMumpsSolver(DMUMPS_STRUC_C& mumps_solver) { mumps_solver.job = JOB_END; dmumps_c(&mumps_solver); diff --git a/src/DirectSolver/DirectSolver-COO-MUMPS-Give/matrixStencil.cpp b/src/DirectSolver/DirectSolver-COO-MUMPS-Give/matrixStencil.cpp index e1bc0207..b317d3b2 100644 --- a/src/DirectSolver/DirectSolver-COO-MUMPS-Give/matrixStencil.cpp +++ b/src/DirectSolver/DirectSolver-COO-MUMPS-Give/matrixStencil.cpp @@ -2,7 +2,7 @@ #ifdef GMGPOLAR_USE_MUMPS -const Stencil& DirectSolverGive::getStencil(int i_r) const +const Stencil& DirectSolver_COO_MUMPS_Give::getStencil(int i_r) const { assert(0 <= i_r && i_r < grid_.nr()); assert(grid_.nr() >= 4); @@ -25,7 +25,7 @@ const Stencil& DirectSolverGive::getStencil(int i_r) const throw std::out_of_range("Invalid index for stencil"); } -int DirectSolverGive::getNonZeroCountSolverMatrix() const +int DirectSolver_COO_MUMPS_Give::getNonZeroCountSolverMatrix() const { const int size_stencil_inner_boundary = DirBC_Interior_ ? 1 : 7; const int size_stencil_next_inner_boundary = DirBC_Interior_ ? 6 : 9; @@ -42,7 +42,7 @@ int DirectSolverGive::getNonZeroCountSolverMatrix() const /* ----------------------------------------------------------------- */ /* If the indexing is not smoother-based, please adjust the indexing */ -int DirectSolverGive::getSolverMatrixIndex(const int i_r, const int i_theta) const +int DirectSolver_COO_MUMPS_Give::getSolverMatrixIndex(const int i_r, const int i_theta) const { const int size_stencil_inner_boundary = DirBC_Interior_ ? 1 : 7; const int size_stencil_next_inner_boundary = DirBC_Interior_ ? 6 : 9; diff --git a/src/DirectSolver/DirectSolver-COO-MUMPS-Take/applySymmetryShift.cpp b/src/DirectSolver/DirectSolver-COO-MUMPS-Take/applySymmetryShift.cpp index 5b3d7d4c..b8b42721 100644 --- a/src/DirectSolver/DirectSolver-COO-MUMPS-Take/applySymmetryShift.cpp +++ b/src/DirectSolver/DirectSolver-COO-MUMPS-Take/applySymmetryShift.cpp @@ -8,7 +8,7 @@ /* Boundary Symmetry Shift */ /* ----------------------- */ -void DirectSolverTake::applySymmetryShiftInnerBoundary(Vector x) const +void DirectSolver_COO_MUMPS_Take::applySymmetryShiftInnerBoundary(Vector x) const { assert(DirBC_Interior_); @@ -45,7 +45,7 @@ void DirectSolverTake::applySymmetryShiftInnerBoundary(Vector x) const } } -void DirectSolverTake::applySymmetryShiftOuterBoundary(Vector x) const +void DirectSolver_COO_MUMPS_Take::applySymmetryShiftOuterBoundary(Vector x) const { assert(level_cache_.cacheDensityProfileCoefficients()); assert(level_cache_.cacheDomainGeometry()); @@ -80,7 +80,7 @@ void DirectSolverTake::applySymmetryShiftOuterBoundary(Vector x) const } } -void DirectSolverTake::applySymmetryShift(Vector x) const +void DirectSolver_COO_MUMPS_Take::applySymmetryShift(Vector x) const { assert(std::ssize(x) == grid_.numberOfNodes()); assert(grid_.nr() >= 4); diff --git a/src/DirectSolver/DirectSolver-COO-MUMPS-Take/buildSolverMatrix.cpp b/src/DirectSolver/DirectSolver-COO-MUMPS-Take/buildSolverMatrix.cpp index 1cc8d28d..8a0a80e3 100644 --- a/src/DirectSolver/DirectSolver-COO-MUMPS-Take/buildSolverMatrix.cpp +++ b/src/DirectSolver/DirectSolver-COO-MUMPS-Take/buildSolverMatrix.cpp @@ -447,7 +447,7 @@ } \ } while (0) -void DirectSolverTake::buildSolverMatrixCircleSection(const int i_r, SparseMatrixCOO& solver_matrix) +void DirectSolver_COO_MUMPS_Take::buildSolverMatrixCircleSection(const int i_r, SparseMatrixCOO& solver_matrix) { assert(level_cache_.cacheDensityProfileCoefficients()); assert(level_cache_.cacheDomainGeometry()); @@ -465,7 +465,8 @@ void DirectSolverTake::buildSolverMatrixCircleSection(const int i_r, SparseMatri } } -void DirectSolverTake::buildSolverMatrixRadialSection(const int i_theta, SparseMatrixCOO& solver_matrix) +void DirectSolver_COO_MUMPS_Take::buildSolverMatrixRadialSection(const int i_theta, + SparseMatrixCOO& solver_matrix) { assert(level_cache_.cacheDensityProfileCoefficients()); assert(level_cache_.cacheDomainGeometry()); @@ -487,7 +488,7 @@ void DirectSolverTake::buildSolverMatrixRadialSection(const int i_theta, SparseM /* ------------------------------------------------------------------------ */ /* If the indexing is not smoother-based, please adjust the access patterns */ -SparseMatrixCOO DirectSolverTake::buildSolverMatrix() +SparseMatrixCOO DirectSolver_COO_MUMPS_Take::buildSolverMatrix() { const int n = grid_.numberOfNodes(); const int nnz = getNonZeroCountSolverMatrix(); diff --git a/src/DirectSolver/DirectSolver-COO-MUMPS-Take/directSolverTake.cpp b/src/DirectSolver/DirectSolver-COO-MUMPS-Take/directSolverTake.cpp index 37bcfca4..acf8a942 100644 --- a/src/DirectSolver/DirectSolver-COO-MUMPS-Take/directSolverTake.cpp +++ b/src/DirectSolver/DirectSolver-COO-MUMPS-Take/directSolverTake.cpp @@ -2,17 +2,17 @@ #ifdef GMGPOLAR_USE_MUMPS -DirectSolverTake::DirectSolverTake(const PolarGrid& grid, const LevelCache& level_cache, - const DomainGeometry& domain_geometry, - const DensityProfileCoefficients& density_profile_coefficients, bool DirBC_Interior, - int num_omp_threads) +DirectSolver_COO_MUMPS_Take::DirectSolver_COO_MUMPS_Take(const PolarGrid& grid, const LevelCache& level_cache, + const DomainGeometry& domain_geometry, + const DensityProfileCoefficients& density_profile_coefficients, + bool DirBC_Interior, int num_omp_threads) : DirectSolver(grid, level_cache, domain_geometry, density_profile_coefficients, DirBC_Interior, num_omp_threads) { solver_matrix_ = buildSolverMatrix(); initializeMumpsSolver(mumps_solver_, solver_matrix_); } -void DirectSolverTake::solveInPlace(Vector solution) +void DirectSolver_COO_MUMPS_Take::solveInPlace(Vector solution) { // Adjusts the right-hand side vector to account for symmetry corrections. // This transforms the system matrixA * solution = rhs into the equivalent system: @@ -24,7 +24,7 @@ void DirectSolverTake::solveInPlace(Vector solution) solveWithMumps(solution); } -DirectSolverTake::~DirectSolverTake() +DirectSolver_COO_MUMPS_Take::~DirectSolver_COO_MUMPS_Take() { finalizeMumpsSolver(mumps_solver_); } diff --git a/src/DirectSolver/DirectSolver-COO-MUMPS-Take/initializeMumps.cpp b/src/DirectSolver/DirectSolver-COO-MUMPS-Take/initializeMumps.cpp index 983d60ee..0ab74615 100644 --- a/src/DirectSolver/DirectSolver-COO-MUMPS-Take/initializeMumps.cpp +++ b/src/DirectSolver/DirectSolver-COO-MUMPS-Take/initializeMumps.cpp @@ -2,7 +2,8 @@ #ifdef GMGPOLAR_USE_MUMPS -void DirectSolverTake::initializeMumpsSolver(DMUMPS_STRUC_C& mumps_solver, SparseMatrixCOO& solver_matrix) +void DirectSolver_COO_MUMPS_Take::initializeMumpsSolver(DMUMPS_STRUC_C& mumps_solver, + SparseMatrixCOO& solver_matrix) { /* * MUMPS (a parallel direct solver) uses 1-based indexing, @@ -102,7 +103,7 @@ void DirectSolverTake::initializeMumpsSolver(DMUMPS_STRUC_C& mumps_solver, Spars } } -void DirectSolverTake::solveWithMumps(Vector result_rhs) +void DirectSolver_COO_MUMPS_Take::solveWithMumps(Vector result_rhs) { mumps_solver_.job = JOB_COMPUTE_SOLUTION; mumps_solver_.nrhs = 1; @@ -115,7 +116,7 @@ void DirectSolverTake::solveWithMumps(Vector result_rhs) } } -void DirectSolverTake::finalizeMumpsSolver(DMUMPS_STRUC_C& mumps_solver) +void DirectSolver_COO_MUMPS_Take::finalizeMumpsSolver(DMUMPS_STRUC_C& mumps_solver) { mumps_solver.job = JOB_END; dmumps_c(&mumps_solver); diff --git a/src/DirectSolver/DirectSolver-COO-MUMPS-Take/matrixStencil.cpp b/src/DirectSolver/DirectSolver-COO-MUMPS-Take/matrixStencil.cpp index 2e27e4bf..10dd2163 100644 --- a/src/DirectSolver/DirectSolver-COO-MUMPS-Take/matrixStencil.cpp +++ b/src/DirectSolver/DirectSolver-COO-MUMPS-Take/matrixStencil.cpp @@ -2,7 +2,7 @@ #ifdef GMGPOLAR_USE_MUMPS -const Stencil& DirectSolverTake::getStencil(int i_r) const +const Stencil& DirectSolver_COO_MUMPS_Take::getStencil(int i_r) const { assert(0 <= i_r && i_r < grid_.nr()); assert(grid_.nr() >= 4); @@ -25,7 +25,7 @@ const Stencil& DirectSolverTake::getStencil(int i_r) const throw std::out_of_range("Invalid index for stencil"); } -int DirectSolverTake::getNonZeroCountSolverMatrix() const +int DirectSolver_COO_MUMPS_Take::getNonZeroCountSolverMatrix() const { const int size_stencil_inner_boundary = DirBC_Interior_ ? 1 : 7; const int size_stencil_next_inner_boundary = DirBC_Interior_ ? 6 : 9; @@ -42,7 +42,7 @@ int DirectSolverTake::getNonZeroCountSolverMatrix() const /* ----------------------------------------------------------------- */ /* If the indexing is not smoother-based, please adjust the indexing */ -int DirectSolverTake::getSolverMatrixIndex(const int i_r, const int i_theta) const +int DirectSolver_COO_MUMPS_Take::getSolverMatrixIndex(const int i_r, const int i_theta) const { const int size_stencil_inner_boundary = DirBC_Interior_ ? 1 : 7; const int size_stencil_next_inner_boundary = DirBC_Interior_ ? 6 : 9; diff --git a/src/DirectSolver/DirectSolver-CSR-LU-Give/buildSolverMatrix.cpp b/src/DirectSolver/DirectSolver-CSR-LU-Give/buildSolverMatrix.cpp index d595a191..11617de4 100644 --- a/src/DirectSolver/DirectSolver-CSR-LU-Give/buildSolverMatrix.cpp +++ b/src/DirectSolver/DirectSolver-CSR-LU-Give/buildSolverMatrix.cpp @@ -730,7 +730,7 @@ } \ } while (0) -void DirectSolverGiveCustomLU::buildSolverMatrixCircleSection(const int i_r, SparseMatrixCSR& solver_matrix) +void DirectSolver_CSR_LU_Give::buildSolverMatrixCircleSection(const int i_r, SparseMatrixCSR& solver_matrix) { const double r = grid_.radius(i_r); for (int i_theta = 0; i_theta < grid_.ntheta(); i_theta++) { @@ -746,7 +746,7 @@ void DirectSolverGiveCustomLU::buildSolverMatrixCircleSection(const int i_r, Spa } } -void DirectSolverGiveCustomLU::buildSolverMatrixRadialSection(const int i_theta, SparseMatrixCSR& solver_matrix) +void DirectSolver_CSR_LU_Give::buildSolverMatrixRadialSection(const int i_theta, SparseMatrixCSR& solver_matrix) { const double theta = grid_.theta(i_theta); for (int i_r = grid_.numberSmootherCircles(); i_r < grid_.nr(); i_r++) { @@ -766,7 +766,7 @@ void DirectSolverGiveCustomLU::buildSolverMatrixRadialSection(const int i_theta, /* ------------------------------------------------------------------------ */ /* If the indexing is not smoother-based, please adjust the access patterns */ -SparseMatrixCSR DirectSolverGiveCustomLU::buildSolverMatrix() +SparseMatrixCSR DirectSolver_CSR_LU_Give::buildSolverMatrix() { const int n = grid_.numberOfNodes(); diff --git a/src/DirectSolver/DirectSolver-CSR-LU-Give/directSolverGive.cpp b/src/DirectSolver/DirectSolver-CSR-LU-Give/directSolverGive.cpp index 5ee9af14..b4ef13ed 100644 --- a/src/DirectSolver/DirectSolver-CSR-LU-Give/directSolverGive.cpp +++ b/src/DirectSolver/DirectSolver-CSR-LU-Give/directSolverGive.cpp @@ -1,6 +1,6 @@ #include "../../../include/DirectSolver/DirectSolver-CSR-LU-Give/directSolverGiveCustomLU.h" -DirectSolverGiveCustomLU::DirectSolverGiveCustomLU(const PolarGrid& grid, const LevelCache& level_cache, +DirectSolver_CSR_LU_Give::DirectSolver_CSR_LU_Give(const PolarGrid& grid, const LevelCache& level_cache, const DomainGeometry& domain_geometry, const DensityProfileCoefficients& density_profile_coefficients, bool DirBC_Interior, int num_omp_threads) @@ -10,11 +10,11 @@ DirectSolverGiveCustomLU::DirectSolverGiveCustomLU(const PolarGrid& grid, const lu_solver_ = SparseLUSolver(solver_matrix_); } -void DirectSolverGiveCustomLU::solveInPlace(Vector solution) +void DirectSolver_CSR_LU_Give::solveInPlace(Vector solution) { lu_solver_.solveInPlace(solution); } -DirectSolverGiveCustomLU::~DirectSolverGiveCustomLU() +DirectSolver_CSR_LU_Give::~DirectSolver_CSR_LU_Give() { } diff --git a/src/DirectSolver/DirectSolver-CSR-LU-Give/matrixStencil.cpp b/src/DirectSolver/DirectSolver-CSR-LU-Give/matrixStencil.cpp index e133f4aa..89b3dc00 100644 --- a/src/DirectSolver/DirectSolver-CSR-LU-Give/matrixStencil.cpp +++ b/src/DirectSolver/DirectSolver-CSR-LU-Give/matrixStencil.cpp @@ -1,6 +1,6 @@ #include "../../../include/DirectSolver/DirectSolver-CSR-LU-Give/directSolverGiveCustomLU.h" -int DirectSolverGiveCustomLU::getStencilSize(int global_index) const +int DirectSolver_CSR_LU_Give::getStencilSize(int global_index) const { int i_r, i_theta; grid_.multiIndex(global_index, i_r, i_theta); @@ -29,7 +29,7 @@ int DirectSolverGiveCustomLU::getStencilSize(int global_index) const throw std::out_of_range("Invalid index for stencil"); } -const Stencil& DirectSolverGiveCustomLU::getStencil(int i_r) const +const Stencil& DirectSolver_CSR_LU_Give::getStencil(int i_r) const { assert(0 <= i_r && i_r < grid_.nr()); assert(grid_.nr() >= 4); @@ -52,7 +52,7 @@ const Stencil& DirectSolverGiveCustomLU::getStencil(int i_r) const throw std::out_of_range("Invalid index for stencil"); } -int DirectSolverGiveCustomLU::getNonZeroCountSolverMatrix() const +int DirectSolver_CSR_LU_Give::getNonZeroCountSolverMatrix() const { const int size_stencil_inner_boundary = DirBC_Interior_ ? 1 : 7; const int size_stencil_next_inner_boundary = DirBC_Interior_ ? 9 : 9; diff --git a/src/DirectSolver/DirectSolver-CSR-LU-Take/buildSolverMatrix.cpp b/src/DirectSolver/DirectSolver-CSR-LU-Take/buildSolverMatrix.cpp index e0ba2a55..efef52c3 100644 --- a/src/DirectSolver/DirectSolver-CSR-LU-Take/buildSolverMatrix.cpp +++ b/src/DirectSolver/DirectSolver-CSR-LU-Take/buildSolverMatrix.cpp @@ -236,7 +236,7 @@ } \ } while (0) -void DirectSolverTakeCustomLU::buildSolverMatrixCircleSection(const int i_r, SparseMatrixCSR& solver_matrix) +void DirectSolver_CSR_LU_Take::buildSolverMatrixCircleSection(const int i_r, SparseMatrixCSR& solver_matrix) { assert(level_cache_.cacheDensityProfileCoefficients()); assert(level_cache_.cacheDomainGeometry()); @@ -254,7 +254,7 @@ void DirectSolverTakeCustomLU::buildSolverMatrixCircleSection(const int i_r, Spa } } -void DirectSolverTakeCustomLU::buildSolverMatrixRadialSection(const int i_theta, SparseMatrixCSR& solver_matrix) +void DirectSolver_CSR_LU_Take::buildSolverMatrixRadialSection(const int i_theta, SparseMatrixCSR& solver_matrix) { assert(level_cache_.cacheDensityProfileCoefficients()); assert(level_cache_.cacheDomainGeometry()); @@ -276,7 +276,7 @@ void DirectSolverTakeCustomLU::buildSolverMatrixRadialSection(const int i_theta, /* ------------------------------------------------------------------------ */ /* If the indexing is not smoother-based, please adjust the access patterns */ -SparseMatrixCSR DirectSolverTakeCustomLU::buildSolverMatrix() +SparseMatrixCSR DirectSolver_CSR_LU_Take::buildSolverMatrix() { const int n = grid_.numberOfNodes(); diff --git a/src/DirectSolver/DirectSolver-CSR-LU-Take/directSolverTake.cpp b/src/DirectSolver/DirectSolver-CSR-LU-Take/directSolverTake.cpp index eb223a3c..d95bf832 100644 --- a/src/DirectSolver/DirectSolver-CSR-LU-Take/directSolverTake.cpp +++ b/src/DirectSolver/DirectSolver-CSR-LU-Take/directSolverTake.cpp @@ -1,6 +1,6 @@ #include "../../../include/DirectSolver/DirectSolver-CSR-LU-Take/directSolverTakeCustomLU.h" -DirectSolverTakeCustomLU::DirectSolverTakeCustomLU(const PolarGrid& grid, const LevelCache& level_cache, +DirectSolver_CSR_LU_Take::DirectSolver_CSR_LU_Take(const PolarGrid& grid, const LevelCache& level_cache, const DomainGeometry& domain_geometry, const DensityProfileCoefficients& density_profile_coefficients, bool DirBC_Interior, int num_omp_threads) @@ -10,11 +10,11 @@ DirectSolverTakeCustomLU::DirectSolverTakeCustomLU(const PolarGrid& grid, const lu_solver_ = SparseLUSolver(solver_matrix_); } -void DirectSolverTakeCustomLU::solveInPlace(Vector solution) +void DirectSolver_CSR_LU_Take::solveInPlace(Vector solution) { lu_solver_.solveInPlace(solution); } -DirectSolverTakeCustomLU::~DirectSolverTakeCustomLU() +DirectSolver_CSR_LU_Take::~DirectSolver_CSR_LU_Take() { } diff --git a/src/DirectSolver/DirectSolver-CSR-LU-Take/matrixStencil.cpp b/src/DirectSolver/DirectSolver-CSR-LU-Take/matrixStencil.cpp index 8ad98cb0..d61d0ead 100644 --- a/src/DirectSolver/DirectSolver-CSR-LU-Take/matrixStencil.cpp +++ b/src/DirectSolver/DirectSolver-CSR-LU-Take/matrixStencil.cpp @@ -1,6 +1,6 @@ #include "../../../include/DirectSolver/DirectSolver-CSR-LU-Take/directSolverTakeCustomLU.h" -int DirectSolverTakeCustomLU::getStencilSize(int global_index) const +int DirectSolver_CSR_LU_Take::getStencilSize(int global_index) const { int i_r, i_theta; grid_.multiIndex(global_index, i_r, i_theta); @@ -29,7 +29,7 @@ int DirectSolverTakeCustomLU::getStencilSize(int global_index) const throw std::out_of_range("Invalid index for stencil"); } -const Stencil& DirectSolverTakeCustomLU::getStencil(int i_r) const +const Stencil& DirectSolver_CSR_LU_Take::getStencil(int i_r) const { assert(0 <= i_r && i_r < grid_.nr()); assert(grid_.nr() >= 4); @@ -52,7 +52,7 @@ const Stencil& DirectSolverTakeCustomLU::getStencil(int i_r) const throw std::out_of_range("Invalid index for stencil"); } -int DirectSolverTakeCustomLU::getNonZeroCountSolverMatrix() const +int DirectSolver_CSR_LU_Take::getNonZeroCountSolverMatrix() const { const int size_stencil_inner_boundary = DirBC_Interior_ ? 1 : 7; const int size_stencil_next_inner_boundary = DirBC_Interior_ ? 9 : 9; diff --git a/src/Level/level.cpp b/src/Level/level.cpp index 46ce42db..e5e4dac8 100644 --- a/src/Level/level.cpp +++ b/src/Level/level.cpp @@ -114,20 +114,20 @@ void Level::initializeDirectSolver(const DomainGeometry& domain_geometry, { #ifdef GMGPOLAR_USE_MUMPS if (stencil_distribution_method == StencilDistributionMethod::CPU_TAKE) { - op_directSolver_ = std::make_unique( + op_directSolver_ = std::make_unique( *grid_, *level_cache_, domain_geometry, density_profile_coefficients, DirBC_Interior, num_omp_threads); } else if (stencil_distribution_method == StencilDistributionMethod::CPU_GIVE) { - op_directSolver_ = std::make_unique( + op_directSolver_ = std::make_unique( *grid_, *level_cache_, domain_geometry, density_profile_coefficients, DirBC_Interior, num_omp_threads); } #else if (stencil_distribution_method == StencilDistributionMethod::CPU_TAKE) { - op_directSolver_ = std::make_unique( + op_directSolver_ = std::make_unique( *grid_, *level_cache_, domain_geometry, density_profile_coefficients, DirBC_Interior, num_omp_threads); } else if (stencil_distribution_method == StencilDistributionMethod::CPU_GIVE) { - op_directSolver_ = std::make_unique( + op_directSolver_ = std::make_unique( *grid_, *level_cache_, domain_geometry, density_profile_coefficients, DirBC_Interior, num_omp_threads); } #endif diff --git a/tests/DirectSolver/directSolver.cpp b/tests/DirectSolver/directSolver.cpp index 3505af85..e30d7ffa 100644 --- a/tests/DirectSolver/directSolver.cpp +++ b/tests/DirectSolver/directSolver.cpp @@ -83,10 +83,10 @@ TEST(DirectSolverTest, directSolver_DirBC_Interior) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, false); - DirectSolverTake directSolverGive_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, - DirBC_Interior, maxOpenMPThreads); - DirectSolverGive directSolverTake_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, - DirBC_Interior, maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take directSolverGive_operator(level.grid(), level.levelCache(), domain_geometry, + *coefficients, DirBC_Interior, maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give directSolverTake_operator(level.grid(), level.levelCache(), domain_geometry, + *coefficients, DirBC_Interior, maxOpenMPThreads); Vector rhs = generate_random_sample_data(level.grid(), 69); @@ -139,10 +139,10 @@ TEST(DirectSolverTest, directSolver_AcrossOrigin) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive directSolverGive_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, - DirBC_Interior, maxOpenMPThreads); - DirectSolverTake directSolverTake_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, - DirBC_Interior, maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give directSolverGive_operator(level.grid(), level.levelCache(), domain_geometry, + *coefficients, DirBC_Interior, maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take directSolverTake_operator(level.grid(), level.levelCache(), domain_geometry, + *coefficients, DirBC_Interior, maxOpenMPThreads); Vector rhs = generate_random_sample_data(level.grid(), 69); @@ -196,8 +196,8 @@ TEST(DirectSolverTest_CircularGeometry, SequentialDirectSolverDirBC_Interior_Cir cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -241,8 +241,8 @@ TEST(DirectSolverTest_CircularGeometry, ParallelDirectSolverDirBC_Interior_Circu cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -286,8 +286,8 @@ TEST(DirectSolverTest_CircularGeometry, SequentialDirectSolverAcrossOrigin_Circu cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -331,8 +331,8 @@ TEST(DirectSolverTest_CircularGeometry, ParallelDirectSolverAcrossOrigin_Circula cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -382,8 +382,8 @@ TEST(DirectSolverTest_ShafranovGeometry, DirectSolverDirBC_Interior_ShafranovGeo cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -429,8 +429,8 @@ TEST(DirectSolverTest_ShafranovGeometry, DirectSolverAcrossOrigin_ShafranovGeome cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -481,8 +481,8 @@ TEST(DirectSolverTest_CzarnyGeometry, DirectSolverDirBC_Interior_CzarnyGeometry) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -529,8 +529,8 @@ TEST(DirectSolverTest_CzarnyGeometry, DirectSolverAcrossOrigin_CzarnyGeometry) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -577,8 +577,8 @@ TEST(DirectSolverTest_CulhamGeometry, DirectSolverDirBC_Interior_CulhamGeometry) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -621,8 +621,8 @@ TEST(DirectSolverTest_CulhamGeometry, DirectSolverAcrossOrigin_CulhamGeometry) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -678,8 +678,8 @@ TEST(DirectSolverTest_CircularGeometry, DirectSolverAcrossOriginHigherPrecision_ cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -723,8 +723,8 @@ TEST(DirectSolverTest_CircularGeometry, DirectSolverAcrossOriginHigherPrecision2 cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGive solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -769,8 +769,8 @@ TEST(DirectSolverTakeTest_CircularGeometry, SequentialDirectSolverDirBC_Interior cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -814,8 +814,8 @@ TEST(DirectSolverTakeTest_CircularGeometry, ParallelDirectSolverDirBC_Interior_C cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -859,8 +859,8 @@ TEST(DirectSolverTakeTest_CircularGeometry, SequentialDirectSolverAcrossOrigin_C cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -904,8 +904,8 @@ TEST(DirectSolverTakeTest_CircularGeometry, ParallelDirectSolverAcrossOrigin_Cir cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -955,8 +955,8 @@ TEST(DirectSolverTakeTest_ShafranovGeometry, DirectSolverDirBC_Interior_Shafrano cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1002,8 +1002,8 @@ TEST(DirectSolverTakeTest_ShafranovGeometry, DirectSolverAcrossOrigin_ShafranovG cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1054,8 +1054,8 @@ TEST(DirectSolverTakeTest_CzarnyGeometry, DirectSolverDirBC_Interior_CzarnyGeome cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1102,8 +1102,8 @@ TEST(DirectSolverTakeTest_CzarnyGeometry, DirectSolverAcrossOrigin_CzarnyGeometr cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1150,8 +1150,8 @@ TEST(DirectSolverTakeTest_CulhamGeometry, DirectSolverDirBC_Interior_CulhamGeome cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1194,8 +1194,8 @@ TEST(DirectSolverTakeTest_CulhamGeometry, DirectSolverAcrossOrigin_CulhamGeometr cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1249,8 +1249,8 @@ TEST(DirectSolverTakeTest_CircularGeometry, DirectSolverAcrossOriginHigherPrecis cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1294,8 +1294,8 @@ TEST(DirectSolverTakeTest_CircularGeometry, DirectSolverAcrossOriginHigherPrecis cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTake solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, - maxOpenMPThreads); + DirectSolver_COO_MUMPS_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); diff --git a/tests/DirectSolver/directSolverNoMumps.cpp b/tests/DirectSolver/directSolverNoMumps.cpp index 49274ad1..ca458a67 100644 --- a/tests/DirectSolver/directSolverNoMumps.cpp +++ b/tests/DirectSolver/directSolverNoMumps.cpp @@ -81,9 +81,9 @@ TEST(DirectSolverTestNoMumps, directSolver_DirBC_Interior) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, false); - DirectSolverTakeCustomLU directSolverGive_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirectSolver_CSR_LU_Take directSolverGive_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); - DirectSolverGiveCustomLU directSolverTake_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirectSolver_CSR_LU_Give directSolverTake_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); Vector rhs = generate_random_sample_data(level.grid(), 69); @@ -137,9 +137,9 @@ TEST(DirectSolverTestNoMumps, directSolver_AcrossOrigin) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU directSolverGive_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirectSolver_CSR_LU_Give directSolverGive_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); - DirectSolverTakeCustomLU directSolverTake_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, + DirectSolver_CSR_LU_Take directSolverTake_operator(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); Vector rhs = generate_random_sample_data(level.grid(), 69); @@ -194,7 +194,7 @@ TEST(DirectSolverTestNoMumps_CircularGeometry, SequentialDirectSolverDirBC_Inter cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -239,7 +239,7 @@ TEST(DirectSolverTestNoMumps_CircularGeometry, ParallelDirectSolverDirBC_Interio cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -284,7 +284,7 @@ TEST(DirectSolverTestNoMumps_CircularGeometry, SequentialDirectSolverAcrossOrigi cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -329,7 +329,7 @@ TEST(DirectSolverTestNoMumps_CircularGeometry, ParallelDirectSolverAcrossOrigin_ cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -380,7 +380,7 @@ TEST(DirectSolverTestNoMumps_ShafranovGeometry, DirectSolverDirBC_Interior_Shafr cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -427,7 +427,7 @@ TEST(DirectSolverTestNoMumps_ShafranovGeometry, DirectSolverAcrossOrigin_Shafran cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -479,7 +479,7 @@ TEST(DirectSolverTestNoMumps_CzarnyGeometry, DirectSolverDirBC_Interior_CzarnyGe cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -527,7 +527,7 @@ TEST(DirectSolverTestNoMumps_CzarnyGeometry, DirectSolverAcrossOrigin_CzarnyGeom cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -575,7 +575,7 @@ TEST(DirectSolverTestNoMumps_CulhamGeometry, DirectSolverDirBC_Interior_CulhamGe cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -619,7 +619,7 @@ TEST(DirectSolverTestNoMumps_CulhamGeometry, DirectSolverAcrossOrigin_CulhamGeom cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -676,7 +676,7 @@ TEST(DirectSolverTestNoMumps_CircularGeometry, DirectSolverAcrossOriginHigherPre cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -721,7 +721,7 @@ TEST(DirectSolverTestNoMumps_CircularGeometry, DirectSolverAcrossOriginHigherPre cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -767,7 +767,7 @@ TEST(DirectSolverTakeCustomLUTest_CircularGeometry, SequentialDirectSolverDirBC_ cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -812,7 +812,7 @@ TEST(DirectSolverTakeCustomLUTest_CircularGeometry, ParallelDirectSolverDirBC_In cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -857,7 +857,7 @@ TEST(DirectSolverTakeCustomLUTest_CircularGeometry, SequentialDirectSolverAcross cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -902,7 +902,7 @@ TEST(DirectSolverTakeCustomLUTest_CircularGeometry, ParallelDirectSolverAcrossOr cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -953,7 +953,7 @@ TEST(DirectSolverTakeCustomLUTest_ShafranovGeometry, DirectSolverDirBC_Interior_ cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1000,7 +1000,7 @@ TEST(DirectSolverTakeCustomLUTest_ShafranovGeometry, DirectSolverAcrossOrigin_Sh cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1052,7 +1052,7 @@ TEST(DirectSolverTakeCustomLUTest_CzarnyGeometry, DirectSolverDirBC_Interior_Cza cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1100,7 +1100,7 @@ TEST(DirectSolverTakeCustomLUTest_CzarnyGeometry, DirectSolverAcrossOrigin_Czarn cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1148,7 +1148,7 @@ TEST(DirectSolverTakeCustomLUTest_CulhamGeometry, DirectSolverDirBC_Interior_Cul cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1192,7 +1192,7 @@ TEST(DirectSolverTakeCustomLUTest_CulhamGeometry, DirectSolverAcrossOrigin_Culha cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1247,7 +1247,7 @@ TEST(DirectSolverTakeCustomLUTest_CircularGeometry, DirectSolverAcrossOriginHigh cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1292,7 +1292,7 @@ TEST(DirectSolverTakeCustomLUTest_CircularGeometry, DirectSolverAcrossOriginHigh cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); diff --git a/tests/ExtrapolatedSmoother/extrapolated_smoother.cpp b/tests/ExtrapolatedSmoother/extrapolated_smoother.cpp index 8af5fc06..f23720c7 100644 --- a/tests/ExtrapolatedSmoother/extrapolated_smoother.cpp +++ b/tests/ExtrapolatedSmoother/extrapolated_smoother.cpp @@ -153,7 +153,7 @@ TEST(ExtrapolatedSmootherTest, extrapolatedSmoother_AcossOrigin) } /* Test 2/2: */ -/* Does the smoother converge to the DirectSolverGiveCustomLU solution? */ +/* Does the smoother converge to the DirectSolver_CSR_LU_Give solution? */ TEST(ExtrapolatedSmootherTest, SequentialExtrapolatedSmootherDirBC_Interior) { @@ -186,7 +186,7 @@ TEST(ExtrapolatedSmootherTest, SequentialExtrapolatedSmootherDirBC_Interior) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -270,7 +270,7 @@ TEST(ExtrapolatedSmootherTest, ParallelExtrapolatedSmootherDirBC_Interior) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -354,7 +354,7 @@ TEST(ExtrapolatedSmootherTest, SequentialExtrapolatedSmootherAcrossOrigin) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -440,7 +440,7 @@ TEST(ExtrapolatedSmootherTest, ParallelExtrapolatedSmootherAcrossOrigin) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -525,7 +525,7 @@ TEST(ExtrapolatedSmootherTest, SequentialExtrapolatedSmootherDirBC_Interior_Smal cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -610,7 +610,7 @@ TEST(ExtrapolatedSmootherTest, ParallelExtrapolatedSmootherDirBC_Interior_Smalle cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -695,7 +695,7 @@ TEST(ExtrapolatedSmootherTest, SequentialExtrapolatedSmootherAcrossOrigin_Smalle cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -778,7 +778,7 @@ TEST(ExtrapolatedSmootherTest, ParallelExtrapolatedSmootherAcrossOrigin_Smallest cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -864,7 +864,7 @@ TEST(ExtrapolatedSmootherTest, SequentialExtrapolatedSmootherTakeDirBC_Interior) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualTake residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -950,7 +950,7 @@ TEST(ExtrapolatedSmootherTest, ParallelExtrapolatedSmootherTakeDirBC_Interior) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualTake residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1034,7 +1034,7 @@ TEST(ExtrapolatedSmootherTest, SequentialExtrapolatedSmootherTakeAcrossOrigin) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualTake residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1118,7 +1118,7 @@ TEST(ExtrapolatedSmootherTest, ParallelExtrapolatedSmootherTakeAcrossOrigin) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualTake residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1201,7 +1201,7 @@ TEST(ExtrapolatedSmootherTest, SequentialExtrapolatedSmootherTakeDirBC_Interior_ cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualTake residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1284,7 +1284,7 @@ TEST(ExtrapolatedSmootherTest, ParallelExtrapolatedSmootherTakeDirBC_Interior_Sm cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualTake residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1367,7 +1367,7 @@ TEST(ExtrapolatedSmootherTest, SequentialExtrapolatedSmootherTakeAcrossOrigin_Sm cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualTake residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1450,7 +1450,7 @@ TEST(ExtrapolatedSmootherTest, ParallelExtrapolatedSmootherTakeAcrossOrigin_Smal cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::IMPLICIT_EXTRAPOLATION, 0); - DirectSolverTakeCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Take solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualTake residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); diff --git a/tests/Smoother/smoother.cpp b/tests/Smoother/smoother.cpp index 9e6cc214..7aa9d107 100644 --- a/tests/Smoother/smoother.cpp +++ b/tests/Smoother/smoother.cpp @@ -183,7 +183,7 @@ TEST(SmootherTest, SequentialSmootherDirBC_Interior) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -262,7 +262,7 @@ TEST(SmootherTest, ParallelSmootherDirBC_Interior) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -341,7 +341,7 @@ TEST(SmootherTest, SequentialSmootherAcrossOrigin) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -420,7 +420,7 @@ TEST(SmootherTest, ParallelSmootherAcrossOrigin) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -498,7 +498,7 @@ TEST(SmootherTest, SequentialSmootherDirBC_Interior_SmallestGrid) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -576,7 +576,7 @@ TEST(SmootherTest, ParallelSmootherDirBC_Interior_SmallestGrid) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -654,7 +654,7 @@ TEST(SmootherTest, SequentialSmootherAcrossOrigin_SmallestGrid) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -732,7 +732,7 @@ TEST(SmootherTest, ParallelSmootherAcrossOrigin_SmallestGrid) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -813,7 +813,7 @@ TEST(SmootherTest, SequentialSmootherTakeDirBC_Interior) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -892,7 +892,7 @@ TEST(SmootherTest, ParallelSmootherTakeDirBC_Interior) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -971,7 +971,7 @@ TEST(SmootherTest, SequentialSmootherTakeAcrossOrigin) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1050,7 +1050,7 @@ TEST(SmootherTest, ParallelSmootherTakeAcrossOrigin) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1128,7 +1128,7 @@ TEST(SmootherTest, SequentialSmootherTakeDirBC_Interior_SmallestGrid) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1206,7 +1206,7 @@ TEST(SmootherTest, ParallelSmootherTakeDirBC_Interior_SmallestGrid) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1284,7 +1284,7 @@ TEST(SmootherTest, SequentialSmootherTakeAcrossOrigin_SmallestGrid) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); @@ -1362,7 +1362,7 @@ TEST(SmootherTest, ParallelSmootherTakeAcrossOrigin_SmallestGrid) cache_density_rpofile_coefficients, cache_domain_geometry); Level level(0, std::move(grid), std::move(levelCache), ExtrapolationType::NONE, 0); - DirectSolverGiveCustomLU solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, + DirectSolver_CSR_LU_Give solver_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads); ResidualGive residual_op(level.grid(), level.levelCache(), domain_geometry, *coefficients, DirBC_Interior, maxOpenMPThreads);