diff --git a/doxygen/initialConditions_8h_source.html b/doxygen/initialConditions_8h_source.html
index 109d6073..4e708364 100644
--- a/doxygen/initialConditions_8h_source.html
+++ b/doxygen/initialConditions_8h_source.html
@@ -171,7 +171,7 @@
Definition: initialConditions.h:50
Definition: initialConditions.h:16
-This is the abstract base class for the matrix free implementation of parabolic and elliptic BVP's,...
Definition: matrixFreePDE.h:68
+This is the abstract base class for the matrix free implementation of parabolic and elliptic BVP's,...
Definition: matrixFreePDE.h:66
diff --git a/doxygen/inputFileReader_8h_source.html b/doxygen/inputFileReader_8h_source.html
index 060c5418..ccdffc7a 100644
--- a/doxygen/inputFileReader_8h_source.html
+++ b/doxygen/inputFileReader_8h_source.html
@@ -149,14 +149,14 @@
-
-
-
-
-
+
+
+
+
+
-
-
+
+
diff --git a/doxygen/matrixFreePDE_8h_source.html b/doxygen/matrixFreePDE_8h_source.html
index 5b20e7fd..b1dc2180 100644
--- a/doxygen/matrixFreePDE_8h_source.html
+++ b/doxygen/matrixFreePDE_8h_source.html
@@ -93,460 +93,458 @@
3 #define MATRIXFREEPDE_H
- 6 #include <deal.II/base/quadrature.h>
- 7 #include <deal.II/base/timer.h>
- 8 #include <deal.II/fe/fe_q.h>
- 9 #include <deal.II/fe/fe_system.h>
- 10 #include <deal.II/fe/fe_values.h>
- 11 #include <deal.II/lac/affine_constraints.h>
- 12 #include <deal.II/lac/vector.h>
- 13 #if (DEAL_II_VERSION_MAJOR == 9 && DEAL_II_VERSION_MINOR > 3)
- 14 # include <deal.II/fe/mapping_fe.h>
-
- 16 #include <deal.II/base/config.h>
- 17 #include <deal.II/base/exceptions.h>
- 18 #include <deal.II/distributed/solution_transfer.h>
- 19 #include <deal.II/distributed/tria.h>
- 20 #include <deal.II/dofs/dof_handler.h>
- 21 #include <deal.II/dofs/dof_tools.h>
- 22 #include <deal.II/grid/grid_tools.h>
- 23 #include <deal.II/grid/manifold_lib.h>
- 24 #include <deal.II/grid/tria.h>
- 25 #include <deal.II/grid/tria_accessor.h>
- 26 #include <deal.II/grid/tria_iterator.h>
- 27 #include <deal.II/lac/la_parallel_vector.h>
- 28 #include <deal.II/matrix_free/fe_evaluation.h>
- 29 #include <deal.II/matrix_free/matrix_free.h>
- 30 #include <deal.II/numerics/vector_tools.h>
-
-
- 33 #include <core/fields.h>
- 34 #include <core/refinement/AdaptiveRefinement.h>
- 35 #include <core/userInputParameters.h>
- 36 #include <core/variableContainer.h>
- 37 #include <core/variableValueContainer.h>
- 38 #include <grains/SimplifiedGrainRepresentation.h>
- 39 #include <nucleation/nucleus.h>
- 40 #include <utilities/computeStress.h>
+ 6 #include <deal.II/base/config.h>
+ 7 #include <deal.II/base/exceptions.h>
+ 8 #include <deal.II/base/quadrature.h>
+ 9 #include <deal.II/base/timer.h>
+ 10 #include <deal.II/distributed/solution_transfer.h>
+ 11 #include <deal.II/distributed/tria.h>
+ 12 #include <deal.II/dofs/dof_handler.h>
+ 13 #include <deal.II/dofs/dof_tools.h>
+ 14 #include <deal.II/fe/fe_q.h>
+ 15 #include <deal.II/fe/fe_system.h>
+ 16 #include <deal.II/fe/fe_values.h>
+ 17 #include <deal.II/fe/mapping_fe.h>
+ 18 #include <deal.II/grid/grid_tools.h>
+ 19 #include <deal.II/grid/manifold_lib.h>
+ 20 #include <deal.II/grid/tria.h>
+ 21 #include <deal.II/grid/tria_accessor.h>
+ 22 #include <deal.II/grid/tria_iterator.h>
+ 23 #include <deal.II/lac/affine_constraints.h>
+ 24 #include <deal.II/lac/la_parallel_vector.h>
+ 25 #include <deal.II/lac/vector.h>
+ 26 #include <deal.II/matrix_free/fe_evaluation.h>
+ 27 #include <deal.II/matrix_free/matrix_free.h>
+ 28 #include <deal.II/numerics/vector_tools.h>
+
+
+ 31 #include <core/fields.h>
+ 32 #include <core/refinement/AdaptiveRefinement.h>
+ 33 #include <core/userInputParameters.h>
+ 34 #include <core/variableContainer.h>
+ 35 #include <core/variableValueContainer.h>
+ 36 #include <grains/SimplifiedGrainRepresentation.h>
+ 37 #include <nucleation/nucleus.h>
+ 38 #include <utilities/computeStress.h>
+
+ 40 using namespace dealii;
- 42 using namespace dealii;
-
-
-
- 46 using scalarType = VectorizedArray<double>;
-
-
- 49 using vectorType = LinearAlgebra::distributed::Vector<double>;
-
-
-
- 53 #define constV(a) make_vectorized_array(a)
-
- 66 template <
int dim,
int degree>
-
-
-
-
-
-
-
-
-
-
-
- 93 create_triangulation(parallel::distributed::Triangulation<dim> &tria)
const;
-
-
-
-
-
-
-
-
- 123 vmult(vectorType &dst,
const vectorType &src)
const;
-
-
-
-
-
-
-
-
-
-
- 155 [[maybe_unused]]
const unsigned int index,
- 156 [[maybe_unused]]
double &scalar_IC,
- 157 [[maybe_unused]] Vector<double> &vector_IC) = 0;
-
-
-
- 172 [[maybe_unused]]
const unsigned int index,
- 173 [[maybe_unused]]
const unsigned int direction,
- 174 [[maybe_unused]]
const double time,
- 175 [[maybe_unused]]
double &scalar_BC,
- 176 [[maybe_unused]] Vector<double> &vector_BC) = 0;
-
-
-
+
+
+ 44 using scalarType = VectorizedArray<double>;
+
+
+ 47 using vectorType = LinearAlgebra::distributed::Vector<double>;
+
+
+
+ 51 #define constV(a) make_vectorized_array(a)
+
+ 64 template <
int dim,
int degree>
+
+
+
+
+
+
+
+
+
+
+
+ 91 create_triangulation(parallel::distributed::Triangulation<dim> &tria)
const;
+
+
+
+
+
+
+
+
+ 121 vmult(vectorType &dst,
const vectorType &src)
const;
+
+
+
+
+
+
+
+
+
+
+ 153 [[maybe_unused]]
const unsigned int index,
+ 154 [[maybe_unused]]
double &scalar_IC,
+ 155 [[maybe_unused]] Vector<double> &vector_IC) = 0;
+
+
+
+ 170 [[maybe_unused]]
const unsigned int index,
+ 171 [[maybe_unused]]
const unsigned int direction,
+ 172 [[maybe_unused]]
const double time,
+ 173 [[maybe_unused]]
double &scalar_BC,
+ 174 [[maybe_unused]] Vector<double> &vector_BC) = 0;
+
+
+
+
+ 179 unsigned int totalDOFs;
- 181 unsigned int totalDOFs;
-
-
-
- 185 const AttributesList &var_attributes;
- 186 const AttributesList &pp_attributes;
-
-
- 189 const static unsigned int CIJ_tensor_size = 2 * dim - 1 + dim / 3;
-
-
-
-
-
-
-
-
+
+
+ 183 const AttributesList &var_attributes;
+ 184 const AttributesList &pp_attributes;
+
+
+ 187 const static unsigned int CIJ_tensor_size = 2 * dim - 1 + dim / 3;
+
+
+
+
+
+
+
+
+
+ 201 std::vector<SimplifiedGrainRepresentation<dim>> simplified_grain_representations;
- 203 std::vector<SimplifiedGrainRepresentation<dim>> simplified_grain_representations;
-
-
- 213 solveIncrement(
bool skip_time_dependent);
-
-
-
-
-
-
-
-
-
-
-
-
- 226 parallel::distributed::Triangulation<dim> triangulation;
-
-
-
-
- 231 std::vector<FESystem<dim> *> FESet;
-
-
-
-
-
-
- 238 std::vector<const AffineConstraints<double> *> constraintsDirichletSet,
-
-
-
-
- 243 std::vector<const DoFHandler<dim> *> dofHandlersSet;
-
-
-
-
-
-
- 250 std::vector<const IndexSet *> locally_relevant_dofsSet;
-
-
- 253 std::vector<AffineConstraints<double> *> constraintsDirichletSet_nonconst,
- 254 constraintsOtherSet_nonconst;
-
- 256 std::vector<DoFHandler<dim> *> dofHandlersSet_nonconst;
-
- 258 std::vector<IndexSet *> locally_relevant_dofsSet_nonconst;
-
-
- 261 std::vector<vectorType *> solutionSet;
-
-
- 264 std::vector<vectorType *> residualSet;
-
-
- 267 std::vector<parallel::distributed::SolutionTransfer<dim, vectorType> *> soltransSet;
-
-
-
-
-
-
- 274 MatrixFree<dim, double> matrixFreeObject;
-
-
-
- 278 vectorType invMscalar;
-
-
-
- 282 vectorType invMvector;
-
-
- 285 vectorType dU_vector, dU_scalar;
-
-
-
- 289 unsigned int currentFieldIndex;
-
-
-
-
-
-
- 296 updateExplicitSolution(
unsigned int fieldIndex);
-
-
-
- 300 updateImplicitSolution(
unsigned int fieldIndex,
unsigned int nonlinear_it_index);
-
-
-
- 304 applyBCs(
unsigned int fieldIndex);
-
-
- 310 compute_element_volume();
-
-
-
-
+
+ 211 solveIncrement(
bool skip_time_dependent);
+
+
+
+
+
+
+
+
+
+
+
+
+ 224 parallel::distributed::Triangulation<dim> triangulation;
+
+
+
+
+ 229 std::vector<FESystem<dim> *> FESet;
+
+
+
+
+
+
+ 236 std::vector<const AffineConstraints<double> *> constraintsDirichletSet,
+
+
+
+
+ 241 std::vector<const DoFHandler<dim> *> dofHandlersSet;
+
+
+
+
+
+
+ 248 std::vector<const IndexSet *> locally_relevant_dofsSet;
+
+
+ 251 std::vector<AffineConstraints<double> *> constraintsDirichletSet_nonconst,
+ 252 constraintsOtherSet_nonconst;
+
+ 254 std::vector<DoFHandler<dim> *> dofHandlersSet_nonconst;
+
+ 256 std::vector<IndexSet *> locally_relevant_dofsSet_nonconst;
+
+
+ 259 std::vector<vectorType *> solutionSet;
+
+
+ 262 std::vector<vectorType *> residualSet;
+
+
+ 265 std::vector<parallel::distributed::SolutionTransfer<dim, vectorType> *> soltransSet;
+
+
+
+
+
+
+ 272 MatrixFree<dim, double> matrixFreeObject;
+
+
+
+ 276 vectorType invMscalar;
+
+
+
+ 280 vectorType invMvector;
+
+
+ 283 vectorType dU_vector, dU_scalar;
+
+
+
+ 287 unsigned int currentFieldIndex;
+
+
+
+
+
+
+ 294 updateExplicitSolution(
unsigned int fieldIndex);
+
+
+
+ 298 updateImplicitSolution(
unsigned int fieldIndex,
unsigned int nonlinear_it_index);
+
+
+
+ 302 applyBCs(
unsigned int fieldIndex);
+
+
+ 308 compute_element_volume();
+
+
+
+
+
+ 317 computeExplicitRHS();
- 319 computeExplicitRHS();
-
- 321 computeNonexplicitRHS();
-
-
-
-
- 326 getLHS(
const MatrixFree<dim, double> &data,
-
- 328 const vectorType &src,
- 329 const std::pair<unsigned int, unsigned int> &cell_range)
const;
-
- 331 bool generatingInitialGuess;
-
- 333 getLaplaceLHS(
const MatrixFree<dim, double> &data,
-
- 335 const vectorType &src,
- 336 const std::pair<unsigned int, unsigned int> &cell_range)
const;
-
+ 319 computeNonexplicitRHS();
+
+
+
+
+ 324 getLHS(
const MatrixFree<dim, double> &data,
+
+ 326 const vectorType &src,
+ 327 const std::pair<unsigned int, unsigned int> &cell_range)
const;
+
+ 329 bool generatingInitialGuess;
+
+ 331 getLaplaceLHS(
const MatrixFree<dim, double> &data,
+
+ 333 const vectorType &src,
+ 334 const std::pair<unsigned int, unsigned int> &cell_range)
const;
+
+
+ 337 setNonlinearEqInitialGuess();
- 339 setNonlinearEqInitialGuess();
+ 339 computeLaplaceRHS(
unsigned int fieldIndex);
- 341 computeLaplaceRHS(
unsigned int fieldIndex);
-
- 343 getLaplaceRHS(
const MatrixFree<dim, double> &data,
-
- 345 const vectorType &src,
- 346 const std::pair<unsigned int, unsigned int> &cell_range)
const;
-
-
-
-
-
- 352 getExplicitRHS(
const MatrixFree<dim, double> &data,
- 353 std::vector<vectorType *> &dst,
- 354 const std::vector<vectorType *> &src,
- 355 const std::pair<unsigned int, unsigned int> &cell_range)
const;
-
-
- 358 getNonexplicitRHS(
const MatrixFree<dim, double> &data,
- 359 std::vector<vectorType *> &dst,
- 360 const std::vector<vectorType *> &src,
- 361 const std::pair<unsigned int, unsigned int> &cell_range)
const;
-
-
-
-
-
- 367 [[maybe_unused]]
const Point<dim, VectorizedArray<double>> q_point_loc,
- 368 [[maybe_unused]]
const VectorizedArray<double> element_volume)
const = 0;
-
-
- 371 nonExplicitEquationRHS(
-
-
- 374 [[maybe_unused]]
const Point<dim, VectorizedArray<double>> q_point_loc,
- 375 [[maybe_unused]]
const VectorizedArray<double> element_volume)
const = 0;
-
-
- 378 equationLHS([[maybe_unused]]
variableContainer<dim, degree, VectorizedArray<double>>
-
- 380 [[maybe_unused]]
const Point<dim, VectorizedArray<double>> q_point_loc,
- 381 [[maybe_unused]]
const VectorizedArray<double> element_volume)
const = 0;
-
-
-
-
-
-
-
- 389 [[maybe_unused]]
const Point<dim, VectorizedArray<double>> q_point_loc,
- 390 [[maybe_unused]]
const VectorizedArray<double> element_volume)
const {};
-
- 392 computePostProcessedFields(std::vector<vectorType *> &postProcessedSet);
-
-
- 395 getPostProcessedFields(
const MatrixFree<dim, double> &data,
- 396 std::vector<vectorType *> &dst,
- 397 const std::vector<vectorType *> &src,
- 398 const std::pair<unsigned int, unsigned int> &cell_range);
-
-
-
-
- 403 std::vector<std::map<types::global_dof_index, double> *> valuesDirichletSet;
-
-
-
- 407 markBoundaries(parallel::distributed::Triangulation<dim> &)
const;
-
-
-
-
-
-
-
+ 341 getLaplaceRHS(
const MatrixFree<dim, double> &data,
+
+ 343 const vectorType &src,
+ 344 const std::pair<unsigned int, unsigned int> &cell_range)
const;
+
+
+
+
+
+ 350 getExplicitRHS(
const MatrixFree<dim, double> &data,
+ 351 std::vector<vectorType *> &dst,
+ 352 const std::vector<vectorType *> &src,
+ 353 const std::pair<unsigned int, unsigned int> &cell_range)
const;
+
+
+ 356 getNonexplicitRHS(
const MatrixFree<dim, double> &data,
+ 357 std::vector<vectorType *> &dst,
+ 358 const std::vector<vectorType *> &src,
+ 359 const std::pair<unsigned int, unsigned int> &cell_range)
const;
+
+
+
+
+
+ 365 [[maybe_unused]]
const Point<dim, VectorizedArray<double>> q_point_loc,
+ 366 [[maybe_unused]]
const VectorizedArray<double> element_volume)
const = 0;
+
+
+ 369 nonExplicitEquationRHS(
+
+
+ 372 [[maybe_unused]]
const Point<dim, VectorizedArray<double>> q_point_loc,
+ 373 [[maybe_unused]]
const VectorizedArray<double> element_volume)
const = 0;
+
+
+ 376 equationLHS([[maybe_unused]]
variableContainer<dim, degree, VectorizedArray<double>>
+
+ 378 [[maybe_unused]]
const Point<dim, VectorizedArray<double>> q_point_loc,
+ 379 [[maybe_unused]]
const VectorizedArray<double> element_volume)
const = 0;
+
+
+
+
+
+
+
+ 387 [[maybe_unused]]
const Point<dim, VectorizedArray<double>> q_point_loc,
+ 388 [[maybe_unused]]
const VectorizedArray<double> element_volume)
const {};
+
+ 390 computePostProcessedFields(std::vector<vectorType *> &postProcessedSet);
+
+
+ 393 getPostProcessedFields(
const MatrixFree<dim, double> &data,
+ 394 std::vector<vectorType *> &dst,
+ 395 const std::vector<vectorType *> &src,
+ 396 const std::pair<unsigned int, unsigned int> &cell_range);
+
+
+
+
+ 401 std::vector<std::map<types::global_dof_index, double> *> valuesDirichletSet;
+
+
+
+ 405 markBoundaries(parallel::distributed::Triangulation<dim> &)
const;
+
+
+
+
+
+
+
+
+
-
-
- 420 setPeriodicityConstraints(AffineConstraints<double> *,
const DoFHandler<dim> *)
const;
-
-
- 433 set_rigid_body_mode_constraints(AffineConstraints<double> *constraints,
- 434 const DoFHandler<dim> *dof_handler,
- 435 const Point<dim> target_point = Point<dim>())
const;
-
-
-
-
-
-
- 442 applyInitialConditions();
-
+ 418 setPeriodicityConstraints(AffineConstraints<double> *,
const DoFHandler<dim> *)
const;
+
+
+ 431 set_rigid_body_mode_constraints(AffineConstraints<double> *constraints,
+ 432 const DoFHandler<dim> *dof_handler,
+ 433 const Point<dim> target_point = Point<dim>())
const;
+
+
+
+
+
+
+ 440 applyInitialConditions();
+
+
+
-
-
-
-
-
-
+
+
+
+
+
+ 450 load_checkpoint_triangulation();
- 452 load_checkpoint_triangulation();
+ 452 load_checkpoint_fields();
- 454 load_checkpoint_fields();
-
- 456 load_checkpoint_time_info();
-
-
- 459 move_file(
const std::string &,
const std::string &);
-
-
- 462 verify_checkpoint_file_exists(
const std::string &filename);
-
+ 454 load_checkpoint_time_info();
+
+
+ 457 move_file(
const std::string &,
const std::string &);
+
+
+ 460 verify_checkpoint_file_exists(
const std::string &filename);
+
+
+
-
-
-
- 468 std::vector<nucleus<dim>> nuclei;
-
-
-
-
- 473 std::vector<nucleus<dim>>
-
+
+ 466 std::vector<nucleus<dim>> nuclei;
+
+
+
+
+ 471 std::vector<nucleus<dim>>
+
+
+ 474 getLocalNucleiList(std::vector<
nucleus<dim>> &newnuclei)
const;
- 476 getLocalNucleiList(std::vector<
nucleus<dim>> &newnuclei)
const;
-
- 478 safetyCheckNewNuclei(std::vector<
nucleus<dim>> newnuclei,
- 479 std::vector<unsigned int> &conflict_ids);
-
- 481 refineMeshNearNuclei(std::vector<
nucleus<dim>> newnuclei);
-
- 483 weightedDistanceFromNucleusCenter(
const Point<dim, double> center,
- 484 const std::vector<double> &semiaxes,
- 485 const Point<dim, double> q_point_loc,
- 486 const unsigned int var_index)
const;
- 487 VectorizedArray<double>
- 488 weightedDistanceFromNucleusCenter(
const Point<dim, double> center,
- 489 const std::vector<double> &semiaxes,
- 490 const Point<dim, VectorizedArray<double>> q_point_loc,
- 491 const unsigned int var_index)
const;
-
-
-
- 495 [[nodiscard]]
virtual double
-
-
-
- 499 [[maybe_unused]]
unsigned int variable_index)
const
-
-
-
-
-
-
-
- 507 getFieldIndex(std::string _name);
-
-
-
- 511 computeIntegral(
double &integratedField,
-
- 513 std::vector<vectorType *> variableSet);
-
-
-
- 517 bool isTimeDependentBVP;
-
-
-
- 521 bool hasExplicitEquation;
- 522 bool hasNonExplicitEquation;
-
-
- 525 unsigned int currentIncrement, currentOutput, currentCheckpoint,
- 526 current_grain_reassignment;
-
-
- 529 mutable TimerOutput computing_timer;
+ 476 safetyCheckNewNuclei(std::vector<
nucleus<dim>> newnuclei,
+ 477 std::vector<unsigned int> &conflict_ids);
+
+ 479 refineMeshNearNuclei(std::vector<
nucleus<dim>> newnuclei);
+
+ 481 weightedDistanceFromNucleusCenter(
const Point<dim, double> center,
+ 482 const std::vector<double> &semiaxes,
+ 483 const Point<dim, double> q_point_loc,
+ 484 const unsigned int var_index)
const;
+ 485 VectorizedArray<double>
+ 486 weightedDistanceFromNucleusCenter(
const Point<dim, double> center,
+ 487 const std::vector<double> &semiaxes,
+ 488 const Point<dim, VectorizedArray<double>> q_point_loc,
+ 489 const unsigned int var_index)
const;
+
+
+
+ 493 [[nodiscard]]
virtual double
+
+
+
+ 497 [[maybe_unused]]
unsigned int variable_index)
const
+
+
+
+
+
+
+
+ 505 getFieldIndex(std::string _name);
+
+
+
+ 509 computeIntegral(
double &integratedField,
+
+ 511 std::vector<vectorType *> variableSet);
+
+
+
+ 515 bool isTimeDependentBVP;
+
+
+
+ 519 bool hasExplicitEquation;
+ 520 bool hasNonExplicitEquation;
+
+
+ 523 unsigned int currentIncrement, currentOutput, currentCheckpoint,
+ 524 current_grain_reassignment;
+
+
+ 527 mutable TimerOutput computing_timer;
+
+ 529 bool first_integrated_var_output_complete;
- 531 bool first_integrated_var_output_complete;
-
-
- 534 double integrated_var;
- 535 unsigned int integral_index;
- 536 std::mutex assembler_lock;
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
+
+ 532 double integrated_var;
+ 533 unsigned int integral_index;
+ 534 std::mutex assembler_lock;
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
Definition: AdaptiveRefinement.h:23
Field class that handles the attributes of each field.
Definition: fields.h:16
-This is the abstract base class for the matrix free implementation of parabolic and elliptic BVP's,...
Definition: matrixFreePDE.h:68
+This is the abstract base class for the matrix free implementation of parabolic and elliptic BVP's,...
Definition: matrixFreePDE.h:66
virtual void setNonUniformDirichletBCs([[maybe_unused]] const Point< dim > &p, [[maybe_unused]] const unsigned int index, [[maybe_unused]] const unsigned int direction, [[maybe_unused]] const double time, [[maybe_unused]] double &scalar_BC, [[maybe_unused]] Vector< double > &vector_BC)=0
Set the spatially or temporally non-uniform boundary conditions. This function is overriden in each a...
-ConditionalOStream pcout
Parallel message stream.
Definition: matrixFreePDE.h:142
-std::vector< Field< dim > > fields
Vector of all the physical fields in the problem. Fields are identified by dimentionality (SCALAR/VEC...
Definition: matrixFreePDE.h:131
-dealii::AlignedVector< dealii::VectorizedArray< double > > element_volume
Vector that stores element volumes.
Definition: matrixFreePDE.h:315
+ConditionalOStream pcout
Parallel message stream.
Definition: matrixFreePDE.h:140
+std::vector< Field< dim > > fields
Vector of all the physical fields in the problem. Fields are identified by dimentionality (SCALAR/VEC...
Definition: matrixFreePDE.h:129
+dealii::AlignedVector< dealii::VectorizedArray< double > > element_volume
Vector that stores element volumes.
Definition: matrixFreePDE.h:313
virtual void setInitialCondition([[maybe_unused]] const Point< dim > &p, [[maybe_unused]] const unsigned int index, [[maybe_unused]] double &scalar_IC, [[maybe_unused]] Vector< double > &vector_IC)=0
Set the initial condition for all fields. This function is overriden in each application.
void initForTests(std::vector< Field< dim >> _fields)
Initializes the data structures for enabling unit tests.
diff --git a/doxygen/nonUniformDirichletBC_8h_source.html b/doxygen/nonUniformDirichletBC_8h_source.html
index 399f0ccf..886fef84 100644
--- a/doxygen/nonUniformDirichletBC_8h_source.html
+++ b/doxygen/nonUniformDirichletBC_8h_source.html
@@ -171,7 +171,7 @@
-This is the abstract base class for the matrix free implementation of parabolic and elliptic BVP's,...
Definition: matrixFreePDE.h:68
+This is the abstract base class for the matrix free implementation of parabolic and elliptic BVP's,...
Definition: matrixFreePDE.h:66