Fix tidy infos in library.

This commit is contained in:
Max Luebke 2022-03-01 19:50:15 +01:00
parent 374a7ef9d9
commit aea3a7afc3
2 changed files with 22 additions and 28 deletions

View File

@ -19,6 +19,7 @@
constexpr int BTCS_MAX_DEP_PER_CELL = 3;
constexpr int BTCS_2D_DT_SIZE = 2;
constexpr double center_eq(double sx) { return -1. - 2. * sx; }
Diffusion::BTCSDiffusion::BTCSDiffusion(unsigned int dim) : grid_dim(dim) {
@ -87,8 +88,8 @@ void Diffusion::BTCSDiffusion::simulate_base(DVectorRowMajor &c,
reserveMemory(size, BTCS_MAX_DEP_PER_CELL);
fillMatrixFromRow(alpha.row(0), bc.row(0), size, dx, time_step);
fillVectorFromRow(c, alpha, bc, Eigen::VectorXd::Constant(size, 0), size,
dx, time_step);
fillVectorFromRow(c, alpha, bc, Eigen::VectorXd::Constant(size, 0), size, dx,
time_step);
solveLES();
@ -230,8 +231,8 @@ inline void Diffusion::BTCSDiffusion::fillMatrixFromRow(
A_matrix.insert(A_size - 2, A_size - 2) = 1;
}
for (int j = 1 + (int)left_constant, k = j - 1; k < size - (int)right_constant;
j++, k++) {
for (int j = 1 + (int)left_constant, k = j - 1;
k < size - (int)right_constant; j++, k++) {
double sx = (alpha[k] * time_step) / (dx * dx);
if (bc[k].type == Diffusion::BC_CONSTANT) {
@ -239,7 +240,7 @@ inline void Diffusion::BTCSDiffusion::fillMatrixFromRow(
continue;
}
A_matrix.insert(j, j) = -1. - 2. * sx;
A_matrix.insert(j, j) = center_eq(sx);
A_matrix.insert(j, (j - 1)) = sx;
A_matrix.insert(j, (j + 1)) = sx;
}
@ -266,15 +267,6 @@ inline void Diffusion::BTCSDiffusion::fillVectorFromRow(
continue;
}
// double y_values[3];
// y_values[0] =
// (row != 0 ? c(row - 1, j) : getBCFromFlux(tmp_bc, c(row, j),
// alpha[j]));
// y_values[1] = c(row, j);
// y_values[2] =
// (row != nrow - 1 ? c(row + 1, j)
// : getBCFromFlux(tmp_bc, c(row, j), alpha[j]));
double t0_c_j = time_step * alpha[j] * (t0_c[j] / (dx * dx));
b_vector[j + 1] = -c[j] - t0_c_j;
}
@ -317,11 +309,12 @@ void Diffusion::BTCSDiffusion::simulate(double *c, double *alpha,
}
}
inline double Diffusion::BTCSDiffusion::getBCFromFlux(boundary_condition bc,
double neighbor_c,
double neighbor_alpha) {
inline auto Diffusion::BTCSDiffusion::getBCFromFlux(boundary_condition bc,
double neighbor_c,
double neighbor_alpha)
-> double {
double val;
double val = 0;
if (bc.type == Diffusion::BC_CLOSED) {
val = neighbor_c;

View File

@ -12,7 +12,6 @@
#include <type_traits>
#include <vector>
namespace Diffusion {
/*!
* Class implementing a solution for a 1/2/3D diffusion equation using backward
@ -126,23 +125,25 @@ private:
Eigen::Map<const DMatrixRowMajor> &alpha,
Eigen::Map<const BCMatrixRowMajor> &bc);
auto calc_t0_c(const DMatrixRowMajor &c,
const DMatrixRowMajor &alpha,
const BCMatrixRowMajor &bc, double time_step, double dx) -> DMatrixRowMajor;
auto calc_t0_c(const DMatrixRowMajor &c, const DMatrixRowMajor &alpha,
const BCMatrixRowMajor &bc, double time_step, double dx)
-> DMatrixRowMajor;
inline void fillMatrixFromRow(const DVectorRowMajor &alpha,
const BCVectorRowMajor &bc, int size, double dx,
double time_step);
inline void fillVectorFromRow(const DVectorRowMajor &c,
const DVectorRowMajor &alpha,
const BCVectorRowMajor &bc,
const DVectorRowMajor &t0_c, int size,
double dx, double time_step);
const DVectorRowMajor &alpha,
const BCVectorRowMajor &bc,
const DVectorRowMajor &t0_c, int size,
double dx, double time_step);
void simulate3D(std::vector<double> &c);
inline void reserveMemory(int size, int max_count_per_line);
inline double getBCFromFlux(Diffusion::boundary_condition bc,
double nearest_value, double neighbor_alpha);
inline static auto getBCFromFlux(Diffusion::boundary_condition bc,
double neighbor_c, double neighbor_alpha)
-> double;
void solveLES();
void updateInternals();