From 25af88f43cdb5eb9fddb8201385d689aa08697c7 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Jean-No=C3=ABl=20Grad?= <jgrad@icp.uni-stuttgart.de> Date: Sat, 4 Sep 2021 00:50:08 +0200 Subject: [PATCH] Fix 756 Doxygen warnings Delete Doxygen blocks duplicated in both .h and .cpp files. Fix incorrect argument names in \param blocks. Fix filenames in \file blocks. Fix broken Doxygen syntax (broken numerated lists containing more than 9 items, invalid HTML tags, broken links in \ref and malformed math equations). Wrap code blocks inside \code ... \endcode. --- apps/tutorials/basics/02_Sweeps.dox | 2 +- .../codegen/03_AdvancedLBMCodegen.dox | 2 +- apps/tutorials/lbm/01_BasicLBM.dox | 16 +++--- .../lbm/02_BasicLBM_ExemplaryExtensions.cpp | 2 +- apps/tutorials/lbm/03_LBLidDrivenCavity.cpp | 2 +- apps/tutorials/lbm/06_LBBoundaryCondition.cpp | 2 +- apps/tutorials/lbm/06_LBBoundaryCondition.dox | 4 +- apps/tutorials/pde/01_SolvingPDE.cpp | 2 +- apps/tutorials/pde/01_SolvingPDE.dox | 6 +-- apps/tutorials/pde/02_HeatEquation.cpp | 2 +- apps/tutorials/pde/02_HeatEquation.dox | 4 +- .../pde/03_HeatEquation_Extensions.cpp | 2 +- doc/Mainpage.dox | 2 +- src/blockforest/BlockForestFile.h | 4 +- src/blockforest/CMakeDefs.in.h | 2 +- src/blockforest/Initialization.cpp | 14 ++--- src/blockforest/Types.h | 2 +- src/blockforest/Utility.cpp | 2 +- src/blockforest/Utility.h | 2 +- .../communication/UniformDirectScheme.impl.h | 2 +- src/boundary/Boundary.h | 18 +++---- src/core/Format.hpp | 2 +- src/core/config/Config.h | 11 ++-- src/core/logging/CMakeDefs.in.h | 2 +- src/core/logging/Initialization.cpp | 6 ++- src/core/math/CMakeDefs.in.h | 2 +- src/core/math/GenericAABB.h | 4 +- src/core/math/GenericAABB.impl.h | 36 ++++++------- src/core/math/Sample.cpp | 2 +- src/core/mpi/BufferSystem.impl.h | 2 +- src/core/mpi/BufferSystemHelper.h | 2 +- src/core/mpi/BufferSystemHelper.impl.h | 2 +- src/core/mpi/Gatherv.h | 8 +-- src/core/mpi/MPIIO.cpp | 2 +- src/core/mpi/MPITextFile.cpp | 1 + src/core/mpi/OpenMPBufferSystem.impl.h | 2 +- src/core/mpi/Reduce.h | 6 +-- src/core/selectable/AllSetSelectableObject.h | 2 +- src/core/selectable/SetSelectableObject.h | 4 +- src/core/timing/Timer.h | 10 ++-- src/core/waLBerlaBuildInfo.in.cpp | 2 +- src/cuda/ExecutionTreeGPU.h | 2 +- src/cuda/FieldAccessor.h | 2 +- src/cuda/FieldIndexing.h | 2 +- src/cuda/FieldIndexing.impl.h | 2 +- src/cuda/FieldIndexing3D.impl.h | 2 +- src/cuda/FieldIndexingXYZ.impl.h | 2 +- src/cuda/GPUCopy.h | 14 ++--- src/cuda/GPUField.impl.h | 2 +- src/cuda/HostFieldAllocator.h | 2 +- src/cuda/communication/CustomMemoryBuffer.h | 2 +- .../communication/CustomMemoryBuffer.impl.h | 2 +- src/executiontree/ExecutionTree.cpp | 2 +- src/executiontree/ExecutionTree.h | 6 +-- src/executiontree/ExecutionTree.impl.h | 2 +- src/executiontree/ExecutionTreeSweep.h | 2 +- src/field/AddToStorage.h | 12 ++--- src/field/CMakeDefs.in.h | 2 +- src/field/Field.impl.h | 43 ++++++++------- src/field/FlagField.impl.h | 18 ++++--- src/field/GhostLayerField.impl.h | 32 +++++------ src/field/GhostRegions.h | 2 + src/field/StabilityChecker.h | 2 +- src/field/allocation/FieldAllocator.h | 16 +++--- src/field/communication/ReducePackInfo.h | 2 +- .../communication/StencilRestrictedPackInfo.h | 2 +- src/field/iterators/FieldIterator.impl.h | 14 ++++- src/field/vtk/VTKWriter.h | 4 +- src/gather/CellGatherPackInfo.h | 2 +- src/geometry/bodies/Ellipsoid.h | 2 +- .../initializer/BoundaryFromImage.impl.h | 2 +- src/geometry/initializer/BoundarySetter.h | 2 +- .../BoundarySetterFlagFieldSpecialization.h | 2 +- .../initializer/ScalarFieldFromBody.h | 18 ++++++- .../initializer/ScalarFieldFromBody.impl.h | 2 +- .../initializer/ScalarFieldFromCellInterval.h | 10 +++- src/geometry/mesh/TriangleMeshIO.h | 8 +-- .../structured/BasicVoxelFileReader.impl.h | 54 +++++++++---------- src/geometry/structured/BinaryRawFile.cpp | 2 +- src/geometry/structured/BinaryRawFile.h | 2 +- .../structured/VoxelFileReader.impl.h | 54 +++++++++---------- src/gui/BlockSliceView/DisplayAdaptor.h | 4 +- src/gui/CMakeDefs.in.h | 2 +- src/lbm/PerformanceLogger.h | 2 +- .../DefaultBoundaryHandlingCollection.h | 2 +- .../DefaultDiffusionBoundaryHandling.h | 2 +- src/lbm/evaluations/Permeability.h | 4 +- src/lbm/geometry/IntersectionRatio.h | 2 +- .../initializer/PoiseuilleInitializer.h | 2 + src/lbm/lattice_model/ForceModel.h | 26 ++++----- src/lbm/vtk/QCriterionCellFilter.h | 2 +- src/lbm/vtk/VelocityCellFilter.h | 2 +- .../virtualmass/InitializeVirtualMassKernel.h | 2 +- ...ticleAccessorWithShapeVirtualMassWrapper.h | 2 +- src/mesa_pd/collision_detection/EPA.h | 10 ++-- src/mesa_pd/collision_detection/GJK.cpp | 7 +-- src/mesa_pd/kernel/InitParticlesForHCSITS.h | 2 +- src/mesa_pd/kernel/IntegrateParticlesHCSITS.h | 1 + src/mesh/blockforest/BlockExclusion.h | 2 +- .../blockforest/BlockForestInitialization.h | 2 +- src/mesh/blockforest/BlockWorkloadMemory.h | 2 +- .../pe/communication/ConvexPolyhedron.cpp | 15 ------ src/mesh/pe/communication/ConvexPolyhedron.h | 3 +- src/mesh/pe/rigid_body/ConvexPolyhedron.cpp | 2 - src/mesh_common/DistanceComputations.h | 2 +- src/pde/iterations/VCycles.impl.h | 2 +- src/pe/Types.h | 2 +- src/pe/ccd/HashGrids.cpp | 14 ++--- src/pe/ccd/HashGrids.h | 5 +- src/pe/collision/EPA.h | 12 +++-- src/pe/collision/GJK.h | 7 +-- src/pe/communication/DynamicMarshalling.h | 3 +- src/pe/communication/Marshalling.cpp | 39 -------------- src/pe/communication/Marshalling.h | 5 +- src/pe/communication/rigidbody/Box.cpp | 13 ----- src/pe/communication/rigidbody/Box.h | 1 - src/pe/communication/rigidbody/Capsule.cpp | 13 ----- src/pe/communication/rigidbody/Capsule.h | 1 - src/pe/communication/rigidbody/Ellipsoid.cpp | 13 ----- src/pe/communication/rigidbody/Ellipsoid.h | 1 - src/pe/communication/rigidbody/Sphere.cpp | 13 ----- src/pe/communication/rigidbody/Sphere.h | 1 - src/pe/communication/rigidbody/Union.h | 1 - src/pe/cr/HCSITS.h | 2 +- src/pe/cr/HCSITS.impl.h | 2 +- src/pe/fcd/AnalyticCollisionDetection.h | 9 ++-- src/pe/raytracing/Color.h | 4 +- src/pe/raytracing/Lighting.h | 8 +-- src/pe/raytracing/Raytracer.cpp | 1 + src/pe/raytracing/Raytracer.h | 9 ++-- src/pe/raytracing/ShadingFunctions.h | 2 +- src/pe/raytracing/ShadingParameters.h | 10 ++-- src/pe/rigidbody/Box.cpp | 6 +-- src/pe/rigidbody/Capsule.cpp | 5 +- src/pe/rigidbody/CapsuleFactory.h | 1 - src/pe/rigidbody/Ellipsoid.cpp | 3 +- src/pe/rigidbody/GeomPrimitive.cpp | 2 +- src/pe/rigidbody/MPIRigidBodyTrait.h | 6 +-- src/pe/rigidbody/Plane.cpp | 8 +-- src/pe/rigidbody/RigidBody.cpp | 3 +- src/pe/rigidbody/RigidBody.h | 5 +- src/pe/rigidbody/Squirmer.cpp | 1 - src/pe/rigidbody/StorageDataHandling.h | 2 +- src/pe/rigidbody/Union.h | 19 +++---- src/pe/synchronization/ClearSynchronization.h | 2 +- src/pe/synchronization/SyncForces.h | 2 +- src/pe/synchronization/SyncNextNeighbors.h | 2 +- src/pe/utility/Distance.h | 2 +- src/pe_coupling/geometry/PeOverlapFraction.h | 2 +- .../restoration/PDFReconstruction.h | 2 +- src/pe_coupling/utility/TimeStep.h | 10 ++-- src/postprocessing/MarchingCubes.impl.h | 2 +- src/python_coupling/CreateConfig.cpp | 2 +- src/python_coupling/CreateConfig.h | 2 +- src/python_coupling/PythonWrapper.h | 2 +- src/python_coupling/export/BasicExport.cpp | 2 +- src/python_coupling/export/BasicExport.h | 2 +- .../export/BlockForestCommunicationExport.h | 2 +- .../BlockForestCommunicationExport.impl.h | 2 +- .../export/BlockForestExport.cpp | 2 +- .../export/BlockForestExport.h | 2 +- .../export/FieldCommunicationExport.h | 2 +- .../export/FieldCommunicationExport.impl.h | 2 +- src/python_coupling/export/MPIExport.cpp | 2 +- src/python_coupling/export/MPIExport.h | 2 +- src/python_coupling/export/VTKExport.cpp | 2 +- src/python_coupling/export/VTKExport.h | 2 +- .../helper/BlockStorageExportHelpers.h | 2 +- src/python_coupling/helper/PybindHelper.h | 2 +- .../helper/PythonIterableToStdVector.h | 2 +- src/sqlite/SQLite.cpp | 17 +++--- src/stencil/Directions.h | 2 +- src/timeloop/ITimeloop.h | 2 +- src/waLBerlaDefinitions.in.h | 2 +- 174 files changed, 466 insertions(+), 530 deletions(-) diff --git a/apps/tutorials/basics/02_Sweeps.dox b/apps/tutorials/basics/02_Sweeps.dox index 2080d217a..138ed0e44 100644 --- a/apps/tutorials/basics/02_Sweeps.dox +++ b/apps/tutorials/basics/02_Sweeps.dox @@ -236,7 +236,7 @@ There is a third sweep concept called "Sweep on Block" where the members of the are in fact block local data.\n This is described in more detail here: \ref sweepTimeloop_onBlock -The next tutorial covers writing a real algorithm, which also requires communication among blocks: \ref tutorial03 +The next tutorial covers writing a real algorithm, which also requires communication among blocks: \ref tutorial_basics_03 \tableofcontents diff --git a/apps/tutorials/codegen/03_AdvancedLBMCodegen.dox b/apps/tutorials/codegen/03_AdvancedLBMCodegen.dox index d8bb02a71..f5a74030f 100644 --- a/apps/tutorials/codegen/03_AdvancedLBMCodegen.dox +++ b/apps/tutorials/codegen/03_AdvancedLBMCodegen.dox @@ -3,7 +3,7 @@ namespace walberla{ /** \page tutorial_codegen03 Tutorial - Code Generation 3: Advanced LBM Code Generation -\section overview Overview +\section advancedlbmcodegen_overview Overview This tutorial demonstrates how to use [pystencils](https://pycodegen.pages.i10git.cs.fau.de/pystencils) and [lbmpy](https://pycodegen.pages.i10git.cs.fau.de/lbmpy) to generate highly optimised and hardware-specific Lattice Boltzmann simulation code within the waLBerla framework. Other than in \ref tutorial_codegen02, we will be generating a full LBM sweep instead of a lattice model class. Furthermore, we will generate a communication pack info class and a sweep to initialise the PDF field. A hardware-specific implementation of a NoSlip boundary handler will also be generated. Those components will then be combined in a waLBerla application for simulating the same shear flow scenario as in the previous tutorial. diff --git a/apps/tutorials/lbm/01_BasicLBM.dox b/apps/tutorials/lbm/01_BasicLBM.dox index 981e26465..733b6e51f 100644 --- a/apps/tutorials/lbm/01_BasicLBM.dox +++ b/apps/tutorials/lbm/01_BasicLBM.dox @@ -5,7 +5,7 @@ namespace walberla { \brief A configurable application for simple LBM simulations -\section tutorial04_overview Overview +\section tutorial01_overview Overview In this tutorial, we finally built a fully functional lattice Boltzmann application with the following features: @@ -19,7 +19,7 @@ there is not much code that we actually have to implement ourselves. \image html tutorial_lbm01_channel.png "airfoil (loaded from a grayscale image) in a 2D channel" -\section tutorial04_paramfile Parameter File +\section tutorial01_paramfile Parameter File This application will be fully configurable by a parameter file so that no recompilation is necessary if some parameters or the geometry has to be changed. @@ -69,9 +69,9 @@ auto blocks = blockforest::createUniformBlockGridFromConfig( walberlaEnv.config( This function assumes that a "DomainSetup" block exists. For a detailed description of possible configuration parameters, see blockforest::createUniformBlockGridFromConfig(). -\section tutorial04_lbmdatastructures Lattice Boltzmann Data Structures +\section tutorial01_lbmdatastructures Lattice Boltzmann Data Structures -\subsection tutorial04_latticemodel Lattice Model +\subsection tutorial01_latticemodel Lattice Model \code typedef lbm::D2Q9< lbm::collision_model::SRT > LatticeModel_T; @@ -95,7 +95,7 @@ A lattice model defines the basic ingredients needed for an LBM simulation: For a more detailed description of lattice models, see lbm::LatticeModelBase -\subsection tutorial04_fields Fields +\subsection tutorial01_fields Fields \code typedef lbm::PdfField< LatticeModel_T > PdfField_T; @@ -129,7 +129,7 @@ BlockDataID pdfFieldId = lbm::addPdfFieldToStorage( blocks, "pdf field", lattic BlockDataID flagFieldId = field::addFlagFieldToStorage< FlagField_T >( blocks, "flag field" ); \endcode -\subsection tutorial04_boundary Boundary Handling +\subsection tutorial01_boundary Boundary Handling waLBerla comes with a set of lattice Boltzmann boundary conditions. They can be found in folder lbm/boundary. All implement a common concept. @@ -186,7 +186,7 @@ BlockDataID boundaryHandlingId = BHFactory::addBoundaryHandlingToStorage( boundariesConfig.getParameter< real_t > ( "pressure1", real_c( 1.0 ) ) ); \endcode -\subsection tutorial04_geometry Geometry +\subsection tutorial01_geometry Geometry To specify where boundaries are located, we could now iterate all blocks, retrieve the boundary handler which was added as block data, and use its member functions like boundary::BoundaryHandling::forceFlag() to setup the domain. @@ -210,7 +210,7 @@ have a look at the documentation of walberla::geometry::initBoundaryHandling(). marked, the remaining cells are tagged with the "domain" flag, i.e. as cells that should be updated by the LBM kernel. -\subsection tutorial04_timeloop Sweep and Time Loop Setup +\subsection tutorial01_timeloop Sweep and Time Loop Setup Having completed the domain setup, the next step is to add all the necessary steps/algorithms to the time loop: - communication to synchronize the ghost layer of the PdfField diff --git a/apps/tutorials/lbm/02_BasicLBM_ExemplaryExtensions.cpp b/apps/tutorials/lbm/02_BasicLBM_ExemplaryExtensions.cpp index 1c491b90c..120e96454 100644 --- a/apps/tutorials/lbm/02_BasicLBM_ExemplaryExtensions.cpp +++ b/apps/tutorials/lbm/02_BasicLBM_ExemplaryExtensions.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file 04_BasicLBM_ExemplaryExtensions.cpp +//! \file 02_BasicLBM_ExemplaryExtensions.cpp //! \author Florian Schornbaum <florian.schornbaum@fau.de> //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/apps/tutorials/lbm/03_LBLidDrivenCavity.cpp b/apps/tutorials/lbm/03_LBLidDrivenCavity.cpp index 95f9ef95e..e5cfc7437 100644 --- a/apps/tutorials/lbm/03_LBLidDrivenCavity.cpp +++ b/apps/tutorials/lbm/03_LBLidDrivenCavity.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file LBLidDrivenCavity.cpp +//! \file 03_LBLidDrivenCavity.cpp //! \author Florian Schornbaum <florian.schornbaum@fau.de> // //====================================================================================================================== diff --git a/apps/tutorials/lbm/06_LBBoundaryCondition.cpp b/apps/tutorials/lbm/06_LBBoundaryCondition.cpp index d4714ba3b..ea41c7251 100644 --- a/apps/tutorials/lbm/06_LBBoundaryCondition.cpp +++ b/apps/tutorials/lbm/06_LBBoundaryCondition.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file 06_LBBoundaryConditions.cpp +//! \file 06_LBBoundaryCondition.cpp //! \author Helen Schottenhamml <helen.schottenhamml@fau.de> // //====================================================================================================================== diff --git a/apps/tutorials/lbm/06_LBBoundaryCondition.dox b/apps/tutorials/lbm/06_LBBoundaryCondition.dox index 82130ebb6..9042ef259 100644 --- a/apps/tutorials/lbm/06_LBBoundaryCondition.dox +++ b/apps/tutorials/lbm/06_LBBoundaryCondition.dox @@ -13,7 +13,7 @@ The physical systems of interest are usually described by a set of partial diffe These boundary conditions are imposed by the physical system through, e.g., walls, inflows, outflows, etc. \n For discrete numerical schemes, the situation is slightly different. Here, boundary conditions are part of the solution routine, and different implementations of the same physical boundary condition may alter the result. Especially in lattice Boltzmann methods, there is a whole zoo of boundary conditions. This can be easily explained by the fact that boundaries are usually prescribed in terms of macroscopic variables. -lattice Boltzmann methods, however, are determined by a set of mesoscopic variables \$f_i(\mathbf{x}, t)$. Different sets of distribution functions may lead to the same hydrodynamic behavior. Eventually, this leads to the question of how to prescribe the mesoscopic variables.\n +lattice Boltzmann methods, however, are determined by a set of mesoscopic variables \f$f_i(\mathbf{x}, t)\f$. Different sets of distribution functions may lead to the same hydrodynamic behavior. Eventually, this leads to the question of how to prescribe the mesoscopic variables.\n In the following, we will discuss different approaches for wall, inflow and outflow boundary conditions and their realization in `waLBerla`. You will learn about the differences between them, their limitations, and how to use them.\n Note that we will not discuss the generation of boundary conditions with `lbmpy`. For this, please refer to \ref tutorial_codegen03. @@ -271,7 +271,7 @@ As this scheme has some deficiencies (accuracy, need for explicitly enforcing th \section tutorial06_pressureBC Pressure Boundary Conditions Now that we have discussed inflows and walls in great detail, only the pressure boundary conditions for the outflows are left.\n -As for the velocity boundary conditions, there are multiple ways to enforce a certain pressure at an outlet. In lattice Boltzmann solvers, however, it is usually the density that is prescribed, as it is more directly related to the pdfs. As density and pressure, in turn, are linked via \$p = c_s^2 \rho$, this is perfectly legitimate. +As for the velocity boundary conditions, there are multiple ways to enforce a certain pressure at an outlet. In lattice Boltzmann solvers, however, it is usually the density that is prescribed, as it is more directly related to the pdfs. As density and pressure, in turn, are linked via \f$p = c_s^2 \rho\f$, this is perfectly legitimate. \subsection tutorial06_simplePressure SimplePressure Our first boundary condition to be discussed is the `SimplePressure` that is based on the anti-bounce-back method. Here, the pdfs are calculated by the fixed boundary density and an approximated boundary velocity. \n diff --git a/apps/tutorials/pde/01_SolvingPDE.cpp b/apps/tutorials/pde/01_SolvingPDE.cpp index 9b5f0477a..766f4f7c3 100644 --- a/apps/tutorials/pde/01_SolvingPDE.cpp +++ b/apps/tutorials/pde/01_SolvingPDE.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file 05_SolvingPDE.cpp +//! \file 01_SolvingPDE.cpp //! \author Christoph Rettinger <christoph.rettinger@fau.de> // //====================================================================================================================== diff --git a/apps/tutorials/pde/01_SolvingPDE.dox b/apps/tutorials/pde/01_SolvingPDE.dox index 47d377db6..7fecad56d 100644 --- a/apps/tutorials/pde/01_SolvingPDE.dox +++ b/apps/tutorials/pde/01_SolvingPDE.dox @@ -7,7 +7,7 @@ namespace walberla { \brief Implementing an iterative solver, initializing fields, and setting Dirichlet boundary conditions by functions, domain setup with an axis-aligned bounding box. File 05_SolvingPDE.cpp. -\section problemdescription Problem Description +\section problemdescription01 Problem Description After learning the basic concepts and data structures of waLBerla, we can now already implement our own solver for an elliptic partial differential equation, discretized by finite differences. The regarded equation, describing the behavior of the unknown \f$u\f$, is: @@ -47,7 +47,7 @@ Coming back to the concepts of waLBerla, this is a perfectly suitable example fo It requires summing up weighted values of the neighboring cells together with the function value of the right-hand side, which is then divided by the weight of the center cell. To avoid data dependencies, i.e., reading neighboring data that has already been updated in a previous step, -two fields (source and destination) are used like in \ref tutorial03. +two fields (source and destination) are used like in \ref tutorial_basics_03. After the sweep, the data pointers are swapped. A possible, but not optimal, implementation of this procedure is shown below. The class has private members `srcID_, dstID_, rhsID_, dx_, dy_` that store the BlockDataIDs of the source, destination, and right-hand side field, and the grid spacings \f$\Delta x\f$ and \f$ \Delta y\f$. @@ -295,7 +295,7 @@ Using the GUI, the converged profile looks like: \image html tutorial_pde01_solution.png -In the next tutorial of the PDE section, \ref pde02, the Jacobi method is used to solve the linear system of equations arising from an implicit time-stepping method +In the next tutorial of the PDE section, \ref tutorial_pde02, the Jacobi method is used to solve the linear system of equations arising from an implicit time-stepping method for the solution of the famous heat equation. It is also shown how to include the functionality to stop the simulation based on the norm of the residual, which is very often used to terminate the iterative solver. diff --git a/apps/tutorials/pde/02_HeatEquation.cpp b/apps/tutorials/pde/02_HeatEquation.cpp index 54a13fd9d..1ff9d3632 100644 --- a/apps/tutorials/pde/02_HeatEquation.cpp +++ b/apps/tutorials/pde/02_HeatEquation.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file 06_HeatEquation.cpp +//! \file 02_HeatEquation.cpp //! \author Christoph Rettinger <christoph.rettinger@fau.de> // //====================================================================================================================== diff --git a/apps/tutorials/pde/02_HeatEquation.dox b/apps/tutorials/pde/02_HeatEquation.dox index 353ad06ee..bdecf8bea 100644 --- a/apps/tutorials/pde/02_HeatEquation.dox +++ b/apps/tutorials/pde/02_HeatEquation.dox @@ -6,12 +6,12 @@ namespace walberla { \brief Unsteady heat equation, implicit time stepping, VTK output and ParaView, parallelization with MPI, residual based termination. File 06_HeatEquation.cpp. -In this tutorial, we will make use of the Jacobi method implemented in \ref pde01 to solve the linear system of equations +In this tutorial, we will make use of the Jacobi method implemented in \ref tutorial_pde01 to solve the linear system of equations that arises by the implicit time discretization of the unsteady heat equation. The implementation is further improved by using VTK output, parallelization with MPI, and a residual based termination of the Jacobi iteration. -\section problemdescription Problem Description +\section problemdescription02 Problem Description The <a target="_blank" href="http://en.wikipedia.org/wiki/Heat_equation">heat equation</a> is a classical example for a parabolic partial differential equation, given by: \f[ diff --git a/apps/tutorials/pde/03_HeatEquation_Extensions.cpp b/apps/tutorials/pde/03_HeatEquation_Extensions.cpp index 6db0cb091..037b3351b 100644 --- a/apps/tutorials/pde/03_HeatEquation_Extensions.cpp +++ b/apps/tutorials/pde/03_HeatEquation_Extensions.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file 06_HeatEquation_Extensions.cpp +//! \file 03_HeatEquation_Extensions.cpp //! \author Christoph Rettinger <christoph.rettinger@fau.de> // //====================================================================================================================== diff --git a/doc/Mainpage.dox b/doc/Mainpage.dox index b69ecfbf6..8ba191634 100644 --- a/doc/Mainpage.dox +++ b/doc/Mainpage.dox @@ -64,7 +64,7 @@ Not all features of the framework are covered in the tutorials. To get further information have a look at the modules pages. Also, the test cases provided in the tests directory are a good starting point for your own developments. -Additionally, there is a folder for full-fledged application codes to be found under \ref apps/benchmarks where also codes of walBerla publications are found. +Additionally, there is a folder for full-fledged application codes to be found under <tt>apps/benchmarks</tt> where also codes of walBerla publications are found. \section cite Please cite us diff --git a/src/blockforest/BlockForestFile.h b/src/blockforest/BlockForestFile.h index af8619b71..ae1ba02ad 100644 --- a/src/blockforest/BlockForestFile.h +++ b/src/blockforest/BlockForestFile.h @@ -50,7 +50,7 @@ namespace internal { * * \subsection SUID SUID MAPPING: * - * 1 | number of SUIDs (= #SUIDs) + * 1 | number of SUIDs (= \#SUIDs) * * \code{.unparsed} * for each SUID: @@ -58,7 +58,7 @@ namespace internal { * length-of-string | UID identifier string * \endcode * - * --> 1 + #SUIDs + number-of-characters-of-all-identifiers-combined BYTES + * --> 1 + \#SUIDs + number-of-characters-of-all-identifiers-combined BYTES * * How the mapping works:\n * SUID #1 is assigned bit #1 ( -> [...]0 0000 0001 )\n diff --git a/src/blockforest/CMakeDefs.in.h b/src/blockforest/CMakeDefs.in.h index f61a93f54..bcb23cdc0 100644 --- a/src/blockforest/CMakeDefs.in.h +++ b/src/blockforest/CMakeDefs.in.h @@ -1,6 +1,6 @@ //====================================================================================================================== /*! - * \file CMakeDefs.h + * \file CMakeDefs.in.h * \brief Definitions for blockforest module configured by cmake */ //====================================================================================================================== diff --git a/src/blockforest/Initialization.cpp b/src/blockforest/Initialization.cpp index 75a1d81c9..288a04a49 100644 --- a/src/blockforest/Initialization.cpp +++ b/src/blockforest/Initialization.cpp @@ -87,7 +87,7 @@ shared_ptr< StructuredBlockForest > createUniformBlockGridFromConfig( const shar * assigned to each process. Setting it to false allows multiple blocks to be assigned to each process. * If the number of blocks is not divisible by the number of processes, the loadbalancer tries to assign * the blocks to processes as evenly as possible. -* 2) Using the number of global cells, #blocks = #processes, if this does not fit, extend the domain +* 2) Using the number of global cells, \#blocks = \#processes, if this does not fit, extend the domain \verbatim { cells < 10,40,90>; // required @@ -751,12 +751,12 @@ createUniformBlockGrid( const std::string& filename, * in this case the number of cells is chosen bigger than requested * * -* \param cells: total number of cells requested -* \param nrOfBlocks: total number of blocks to distribute the cells to -* \param[out] blocks: calculated number of blocks in x/y/z -* \param[out] cellsPerBlock: how many cells to put on each block - it may happen that divisibility of the number of cells requested prevents a distribution -* in this case the number of cells is chosen (slightly) bigger than requested +* \param cells total number of cells requested +* \param nrOfBlocks total number of blocks to distribute the cells to +* \param[out] blocksOut calculated number of blocks in x/y/z +* \param[out] cellsPerBlock how many cells to put on each block +* it may happen that divisibility of the number of cells requested prevents a distribution +* in this case the number of cells is chosen (slightly) bigger than requested * * Example: in: cells = (10,15,16) * in: blocks = 8 diff --git a/src/blockforest/Types.h b/src/blockforest/Types.h index dc61b3551..68beb9ebc 100644 --- a/src/blockforest/Types.h +++ b/src/blockforest/Types.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file types.h +//! \file Types.h //! \ingroup blockforest //! \author Florian Schornbaum <florian.schornbaum@fau.de> // diff --git a/src/blockforest/Utility.cpp b/src/blockforest/Utility.cpp index cba91fa60..b31f41475 100644 --- a/src/blockforest/Utility.cpp +++ b/src/blockforest/Utility.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file utility.cpp +//! \file Utility.cpp //! \ingroup blockforest //! \author Florian Schornbaum <florian.schornbaum@fau.de> // diff --git a/src/blockforest/Utility.h b/src/blockforest/Utility.h index 7379f7240..8a6f30461 100644 --- a/src/blockforest/Utility.h +++ b/src/blockforest/Utility.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file utility.h +//! \file Utility.h //! \ingroup blockforest //! \author Florian Schornbaum <florian.schornbaum@fau.de> // diff --git a/src/blockforest/communication/UniformDirectScheme.impl.h b/src/blockforest/communication/UniformDirectScheme.impl.h index 6919227be..7f61c164a 100644 --- a/src/blockforest/communication/UniformDirectScheme.impl.h +++ b/src/blockforest/communication/UniformDirectScheme.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BufferlessScheme.cpp +//! \file UniformDirectScheme.impl.h //! \ingroup blockforest //! \author MartinBauer <martin.bauer@fau.de> // diff --git a/src/boundary/Boundary.h b/src/boundary/Boundary.h index d7b3679f8..24b74f643 100644 --- a/src/boundary/Boundary.h +++ b/src/boundary/Boundary.h @@ -52,7 +52,7 @@ private: * Every boundary class must be derived from this class and implement the following concept/member functions (for some * exemplary implementations look at classes NoSlip, FreeSlip, UBB, or SimpleUBB in module lbm/boundary): * -* 1. "static shared_ptr<BoundaryConfiguration> createConfiguration( const Config::BlockHandle & config )" +* 1. "static shared_ptr<BoundaryConfiguration> createConfiguration( const Config::BlockHandle & config )" * This function is used to extract parameters from a configuration file and pass them to the boundary condition. * Meaning: This function defines how the parameter specification for this boundary condition must look like in the * configuration file. @@ -60,35 +60,35 @@ private: * "{ return make_shared<BoundaryConfiguration>(); }" * If you do need to pass parameters, these parameters must be implemented in terms of a derived class of * "BoundaryConfiguration" (as an example, see class "UBB"). -* 2. "void pushFlags( std::vector< FlagUID >& uids )" +* 2. "void pushFlags( std::vector< FlagUID >& uids )" * This function receives (by reference) a vector and must insert (using push_back!) all FlagUIDs into this vector * that mark cells as boundary cells that must be treated by this boundary condition. -* 3. "void beforeBoundaryTreatment()" +* 3. "void beforeBoundaryTreatment()" * This function is called once before the boundary handler starts the boundary treatment. Of course, this function * is called every time the boundary treatment of the boundary handler is triggered (normally once per time step). -* 4. "void afterBoundaryTreatment()" +* 4. "void afterBoundaryTreatment()" * Just like "beforeBoundaryTreatment", this function is called once after the boundary handler has finished the * boundary treatment. -* 5. "template< typename Buffer_T > +* 5. "template< typename Buffer_T > * void packCell( Buffer_T & buffer, const cell_idx_t x, const cell_idx_t y, const cell_idx_t z )" * This function is called every time a boundary cell that is handled by this boundary class is serialized. If * the boundary condition stores additional parameters for the boundary cell (x,y,z) these parameters must be * serialized and stored in the buffer "buffer". [5) serializes and 6) deserializes, both functions must match] -* 6. "template< typename Buffer_T > +* 6. "template< typename Buffer_T > * void registerCell( Buffer_T & buffer, * const flag_t flag, const cell_idx_t x, const cell_idx_t y, const cell_idx_t z )" * This function is called every time a boundary cell that is handled by this boundary class is deserialized. The * flag which was set (must be part of this->mask_!), the cell (x,y,z), and a buffer that potentially stores * parameters are passed. [5) serializes and 6) deserializes, both functions must match] -* 7. "void registerCell( const flag_t flag, const cell_idx_t x, const cell_idx_t y, const cell_idx_t z, +* 7. "void registerCell( const flag_t flag, const cell_idx_t x, const cell_idx_t y, const cell_idx_t z, * const BoundaryConfiguration & parameter )" * This function is called every time a boundary that is handled by this boundary class is set at the boundary * handler. The flag which was set (must be part of this->mask_!), the cell (x,y,z), and a corresponding parameter * are passed. -* 8. "void registerCells( const flag_t flag, const CellInterval & cells, const BoundaryConfiguration & parameter )" +* 8. "void registerCells( const flag_t flag, const CellInterval & cells, const BoundaryConfiguration & parameter )" * Just like "registerCell", only this function is called if a boundary that is handled by this boundary class is * set for each cell in a specific cell interval (-> "cells"). -* 9. "template< typename CellIterator > +* 9. "template< typename CellIterator > * void registerCells( const flag_t flag, const CellIterator & begin, const CellIterator & end, * const BoundaryConfiguration & parameter )" * Just like the previous two functions, only this function is called if multiple boundary cells that are handled diff --git a/src/core/Format.hpp b/src/core/Format.hpp index 078acd143..c535b4334 100644 --- a/src/core/Format.hpp +++ b/src/core/Format.hpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Format.h +//! \file Format.hpp //! \ingroup core //! \author Dominik Thoennes <dominik.thoennes@fau.de> // diff --git a/src/core/config/Config.h b/src/core/config/Config.h index 51d16fdee..00e56397d 100644 --- a/src/core/config/Config.h +++ b/src/core/config/Config.h @@ -197,7 +197,7 @@ public: inline Parameter<T> getParameter( std::string key ) const; template< typename T > - inline Parameter<T> getParameter( const std::string & key, const T & defaultValue ) const; + inline Parameter<T> getParameter( const std::string & key, const T & def ) const; inline bool setParameter( const std::string & key, const std::string & value ); @@ -278,7 +278,7 @@ public: inline Parameter<T> getParameter( const std::string & key ) const; template< typename T > - inline Parameter<T> getParameter( const std::string & key, const T& defaultValue ) const; + inline Parameter<T> getParameter( const std::string & key, const T& def ) const; bool isValid() const { return block_ != nullptr; } operator bool() const { return isValid(); } @@ -346,7 +346,7 @@ public: inline Parameter<T> getParameter( const std::string& key ) const; template< typename T > - inline Parameter<T> getParameter( const std::string& key, const T & defaultValue ) const; + inline Parameter<T> getParameter( const std::string& key, const T & def ) const; inline iterator begin(); @@ -514,7 +514,7 @@ inline Config::Parameter<Type> Config::getParameter( const std::string & key ) c //********************************************************************************************************************** -/*!\fn Config::Parameter<T> Config::getParameter( const std::string& key, const T& ) const +/*!\fn Config::Parameter<T> Config::getParameter( const std::string& key, const T& def ) const // \brief Returns an extracted parameter. // // \param key The key of the extracted parameter. @@ -1093,6 +1093,7 @@ inline const std::string& Config::BlockHandle::getKey() const /*!\fn bool Config::BlockHandle::isDefined( std::string key ) const // \brief Checks if a parameter was defined in the parameter file. // +// \param key The parameter key to be checked. // \return \a true if the parameter was defined, \a false if the parameter wasn't defined. */ inline bool Config::BlockHandle::isDefined( std::string key ) const @@ -1118,7 +1119,7 @@ inline Config::Parameter<Type> Config::BlockHandle::getParameter( const std::str //********************************************************************************************************************** //********************************************************************************************************************** -/*!\fn Config::Parameter<T> Config::BlockHandle::getParameter( const std::string& key, const T & ) const +/*!\fn Config::Parameter<T> Config::BlockHandle::getParameter( const std::string& key, const T & def ) const // \brief Returns an extracted parameter. // // \param key The key of the extracted parameter. diff --git a/src/core/logging/CMakeDefs.in.h b/src/core/logging/CMakeDefs.in.h index 1ee97f43f..05abf9750 100644 --- a/src/core/logging/CMakeDefs.in.h +++ b/src/core/logging/CMakeDefs.in.h @@ -1,6 +1,6 @@ //====================================================================================================================== /*! - * \file CMakeDefs.h + * \file CMakeDefs.in.h * \brief Definitions for core/logging configured by cmake */ //====================================================================================================================== diff --git a/src/core/logging/Initialization.cpp b/src/core/logging/Initialization.cpp index ca442e712..d1dfe6099 100644 --- a/src/core/logging/Initialization.cpp +++ b/src/core/logging/Initialization.cpp @@ -73,7 +73,7 @@ static void parseIgnoreBlocks( const Config::Blocks & ignoreBlocks, std::vector< * This initialization function reads data stored in a configuration file and uses thi data to configure the logging * singleton. * The structure of the configuration file which is recognized by this function must look like as follows: -* \code +* \code{.unparsed} * Logging { // the whole 'Logging' block is optional * * logLevel warning|info|progress|detail|tracing; // optional, default=info @@ -102,7 +102,7 @@ static void parseIgnoreBlocks( const Config::Blocks & ignoreBlocks, std::vector< * * Log messages can be ignored by specifying a regular expression on the filename and line number of the source * file the log message originates from. The regex has to be specified in an ignore block as the parameter -* callerPathPattern. If the regular expression is found somewhere in the string <filename>:<line number>, +* callerPathPattern. If the regular expression is found somewhere in the string `<filename>:<line number>`, * the log message is ignored. To divide components of your path always uses slashes! * They will automatically be converted to the regex (/|\\), matching slashes and back-slashes. For fancy regexes * you can use perl regex syntax. @@ -110,11 +110,13 @@ static void parseIgnoreBlocks( const Config::Blocks & ignoreBlocks, std::vector< * Note that you cannot ignore Errors since they abort your program! * * Examples: +* \code{.unparsed} * ignore { callerPathPattern /src/core/; } // ignores log messages from core * ignore { callerPathPattern /src/vtk/; } // ignores log messages from vtk * ignore { callerPathPattern (/src/core/|/src/vtk/); } // ignores log messages from core & vtk * ignore { callerPathPattern /src/core/FILENAME.h:416; } // ignores a specific log message * ignoreWarning { callerPathPattern /src/core/FILENAME.h:212; } // ignores a specific warning +* \endcode{.unparsed} * * \param config The configuration */ diff --git a/src/core/math/CMakeDefs.in.h b/src/core/math/CMakeDefs.in.h index 3ee631f55..66ad0396f 100644 --- a/src/core/math/CMakeDefs.in.h +++ b/src/core/math/CMakeDefs.in.h @@ -1,6 +1,6 @@ //====================================================================================================================== /*! - * \file CMakeDefs.h + * \file CMakeDefs.in.h * \brief Definitions for core/math configured by cmake */ //====================================================================================================================== diff --git a/src/core/math/GenericAABB.h b/src/core/math/GenericAABB.h index 5d326b5af..6ca2ce176 100644 --- a/src/core/math/GenericAABB.h +++ b/src/core/math/GenericAABB.h @@ -132,9 +132,9 @@ public: inline value_type intersectionVolume( const GenericAABB & other ) const; inline GenericAABB getIntersection( const GenericAABB & other ) const; - inline bool isIdentical( const GenericAABB & rhs ) const; + inline bool isIdentical( const GenericAABB & other ) const; - inline bool isEqual( const GenericAABB & rhs ) const; + inline bool isEqual( const GenericAABB & other ) const; inline value_type sqDistance( const vector_type & point ) const; inline value_type sqSignedDistance( const vector_type & point ) const; diff --git a/src/core/math/GenericAABB.impl.h b/src/core/math/GenericAABB.impl.h index 254c0d00e..e62757bfa 100644 --- a/src/core/math/GenericAABB.impl.h +++ b/src/core/math/GenericAABB.impl.h @@ -230,8 +230,8 @@ GenericAABB< T >::GenericAABB( const value_type minX, const value_type minY, con /** * \brief Builds a GenericAABB from a min- and a maxCorner * - * \param minCorner corner with minimal values - * \param maxCorner corner with maximal values + * \param theMinCorner corner with minimal values + * \param theMaxCorner corner with maximal values * * \pre minCorner.x <= maxCorner.x && minCorner.y <= maxCorner.y && minCorner.z <= maxCorner.z */ @@ -751,8 +751,8 @@ GenericAABB< T > GenericAABB< T >::getScaled( const value_type factor ) const /** * \brief Creates a new GenericAABB by scaling this one * - * \param factor Vector of scaling factors by which the bounding box gets scaled on the - * respective axises. + * \param factors Vector of scaling factors by which the bounding box gets scaled on the + * respective axises. * * \returns The scaled GenericAABB */ @@ -1450,10 +1450,14 @@ void GenericAABB< T >::init( InputIterator first, InputIterator last ) /** * \brief Reinitializes this GenericAABB from a min- and a maxCorner * - * \param minCorner corner with minimal values - * \param maxCorner corner with maximal values + * \param minX x-coordinate of the minCorner + * \param minY y-coordinate of the minCorner + * \param minZ z-coordinate of the minCorner + * \param maxX x-coordinate of the maxCorner + * \param maxY y-coordinate of the maxCorner + * \param maxZ z-coordinate of the maxCorner * - * \pre minCorner.x <= maxCorner.x && minCorner.y <= maxCorner.y && minCorner.z <= maxCorner.z + * \pre minX <= maxX && minY <= maxY && minZ <= maxZ */ template< typename T > void GenericAABB< T >::initMinMaxCorner( const value_type minX, const value_type minY, const value_type minZ, @@ -1475,14 +1479,10 @@ void GenericAABB< T >::initMinMaxCorner( const value_type minX, const value_type /** * \brief Reinitializes this GenericAABB from a min- and a maxCorner * - * \param minX x-coordinate of the minCorner - * \param minY y-coordinate of the minCorner - * \param minZ z-coordinate of the minCorner - * \param maxX x-coordinate of the maxCorner - * \param maxY y-coordinate of the maxCorner - * \param maxZ z-coordinate of the maxCorner + * \param theMinCorner corner with minimal values + * \param theMaxCorner corner with maximal values * - * \pre x0 <= x1 && y0 <= y1 && z0 <= z1 + * \pre theMinCorner.x <= theMaxCorner.x && theMinCorner.y <= theMaxCorner.y && theMinCorner.z <= theMaxCorner.z */ template< typename T > void GenericAABB< T >::initMinMaxCorner( const vector_type & theMinCorner, const vector_type & theMaxCorner ) @@ -1498,7 +1498,7 @@ void GenericAABB< T >::initMinMaxCorner( const vector_type & theMinCorner, const * \brief Sets the minimum and maximum for one axis * * \param index 0 for x, 1 for y, 2 for z axis - * \param value* the smaller of the two values is taken as minimum, the other as maximum + * \param value1,value2 the smaller of the two values is taken as minimum, the other as maximum */ template< typename T > void GenericAABB< T >::setAxisBounds( const uint_t index, const value_type value1, const value_type value2 ) @@ -1567,7 +1567,7 @@ void GenericAABB< T >::extend( const vector_type & eps ) * * AABB gets translated such that its center matches the given center. * - * \param new center location + * \param center new center location */ template< typename T > void GenericAABB< T >::setCenter( const vector_type & center ) @@ -1616,8 +1616,8 @@ void GenericAABB< T >::scale( const value_type factor ) /** * \brief Scales this GenericAABB * - * \param factor Vector of scaling factors by which the bounding box gets scaled on the - * respective axises. + * \param factors Vector of scaling factors by which the bounding box gets scaled on the + * respective axises. */ template< typename T > void GenericAABB< T >::scale( const vector_type & factors ) diff --git a/src/core/math/Sample.cpp b/src/core/math/Sample.cpp index a85954e2a..303656736 100644 --- a/src/core/math/Sample.cpp +++ b/src/core/math/Sample.cpp @@ -115,7 +115,7 @@ real_t Sample::median() const * The variance calculated here is the _uncorrected_ variance. * See: http://en.wikipedia.org/w/index.php?title=Bessel%27s_correction&oldid=526066331 * - * \param mean the mean() + * \param theMean the mean() * * \returns The uncorrected variance. **********************************************************************************************************************/ diff --git a/src/core/mpi/BufferSystem.impl.h b/src/core/mpi/BufferSystem.impl.h index f3d753986..4cbd884ba 100644 --- a/src/core/mpi/BufferSystem.impl.h +++ b/src/core/mpi/BufferSystem.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file GenericBufferSystem.cpp +//! \file BufferSystem.impl.h //! \ingroup core //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/core/mpi/BufferSystemHelper.h b/src/core/mpi/BufferSystemHelper.h index 78b77c5ed..5603db560 100644 --- a/src/core/mpi/BufferSystemHelper.h +++ b/src/core/mpi/BufferSystemHelper.h @@ -83,7 +83,7 @@ namespace internal { /*************************************************************************************************************//** * Waits for the next receive to complete and returns. * - * \param recvInfo the same receive info that was passed to scheduleReceives() + * \param recvInfos the same receive info that was passed to scheduleReceives() * * \return The rank where the data was received -> recvInfos[rank] is now valid * INVALID_RANK if all messages were received. diff --git a/src/core/mpi/BufferSystemHelper.impl.h b/src/core/mpi/BufferSystemHelper.impl.h index fc2c6a5ae..e6236f100 100644 --- a/src/core/mpi/BufferSystemHelper.impl.h +++ b/src/core/mpi/BufferSystemHelper.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BufferSystemHelper.cpp +//! \file BufferSystemHelper.impl.h //! \ingroup core //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/core/mpi/Gatherv.h b/src/core/mpi/Gatherv.h index 7a9de2652..0a26b1367 100644 --- a/src/core/mpi/Gatherv.h +++ b/src/core/mpi/Gatherv.h @@ -198,11 +198,11 @@ std::vector< std::string > allGatherv( const std::vector< std::string > & values * - the buffer contents are gathered on process with targetRank * - buffer contents are sorted by rank and stored consecutively in a mpi::RecvBuffer * -* \param sendBuffer [in] sendBuffer with (possibly) different size on each process -* \param recvBuffer [out] recvBuffer which is left unchanged on all processes but targetRank +* \param[in] sendBuffer sendBuffer with (possibly) different size on each process +* \param[out] recvBuffer recvBuffer which is left unchanged on all processes but targetRank * on targetRank recvBuffer holds the gathered result -* \param targetRank [in] rank of the process where data is gathered -* \param comm [in] mpi communicator to use +* \param[in] targetRank rank of the process where data is gathered +* \param[in] comm mpi communicator to use */ //******************************************************************************************************************* void gathervBuffer( const mpi::SendBuffer & sendBuffer, mpi::RecvBuffer & recvBuffer, int targetRank = 0, MPI_Comm comm = MPI_COMM_WORLD ); diff --git a/src/core/mpi/MPIIO.cpp b/src/core/mpi/MPIIO.cpp index b8eb53a7b..13b90c7a2 100644 --- a/src/core/mpi/MPIIO.cpp +++ b/src/core/mpi/MPIIO.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file MPIIO.cppp +//! \file MPIIO.cpp //! \ingroup core //! \author Florian Schornbaum <florian.schornbaum@fau.de> //! \author Martin Bauer <martin.bauer@fau.de> diff --git a/src/core/mpi/MPITextFile.cpp b/src/core/mpi/MPITextFile.cpp index 2d78b1acd..5d9592d13 100644 --- a/src/core/mpi/MPITextFile.cpp +++ b/src/core/mpi/MPITextFile.cpp @@ -40,6 +40,7 @@ namespace mpi * * \param filename The name of the file to be written * \param processLocalPart The part of the file belonging to the calling process (size may differ among processes) + * \param comm The MPI communicator used for communication */ //====================================================================================================================== void writeMPITextFile(const std::string& filename, const std::string& processLocalPart, diff --git a/src/core/mpi/OpenMPBufferSystem.impl.h b/src/core/mpi/OpenMPBufferSystem.impl.h index dd0efe661..5230d5b9d 100644 --- a/src/core/mpi/OpenMPBufferSystem.impl.h +++ b/src/core/mpi/OpenMPBufferSystem.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file OpenMPBufferSystem.cpp +//! \file OpenMPBufferSystem.impl.h //! \ingroup core //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/core/mpi/Reduce.h b/src/core/mpi/Reduce.h index c93e9443f..8f1b8e0f1 100644 --- a/src/core/mpi/Reduce.h +++ b/src/core/mpi/Reduce.h @@ -434,10 +434,10 @@ void allReduceInplace( std::vector<T> & values, Operation operation, MPI_Comm co //====================================================================================================================== /*! * \brief Reduces values in a std::vector<bool> over all processes in-place - * + * * Specialization of allReduceInplace<T> - * - * \param values The boolean values to be reduced + * + * \param bools The boolean values to be reduced * \param operation The operation to be performed (one of BITWISE_AND, BITWISE_OR or BITWISE_XOR) * \param comm The MPI communicator used for communication */ diff --git a/src/core/selectable/AllSetSelectableObject.h b/src/core/selectable/AllSetSelectableObject.h index 996f1166a..683f02833 100644 --- a/src/core/selectable/AllSetSelectableObject.h +++ b/src/core/selectable/AllSetSelectableObject.h @@ -37,7 +37,7 @@ namespace selectable { * \brief Implementation of SelectableObject using sets (see "AllSet.h") as selection attributes * * AllSetSelectableObject is an implementation of SelectableObject that stores objects of type T which are attached -* with selection attributes of type AllSet<U>. For information on which objects are selected given a certain set as +* with selection attributes of type `AllSet<U>`. For information on which objects are selected given a certain set as * selection request see the documentation of the function "select". */ //********************************************************************************************************************** diff --git a/src/core/selectable/SetSelectableObject.h b/src/core/selectable/SetSelectableObject.h index e43740aef..cd4ae982b 100644 --- a/src/core/selectable/SetSelectableObject.h +++ b/src/core/selectable/SetSelectableObject.h @@ -38,8 +38,8 @@ namespace selectable { * selection attributes, and objects of type Set (see "Set.h") as selector * * SetSelectableObject is an implementation of SelectableObject that stores objects of type T which are attached with -* selection attributes of type SetSelectionPair<U>. Every object of type SetSelectionPair<U> contains two sets of -* type Set<U> - one "include" and one "exclude" set. For information on which objects are selected given a certain +* selection attributes of type `SetSelectionPair<U>`. Every object of type `SetSelectionPair<U>` contains two sets of +* type `Set<U>` - one "include" and one "exclude" set. For information on which objects are selected given a certain * selection request see the documentation of the function "select". */ //********************************************************************************************************************** diff --git a/src/core/timing/Timer.h b/src/core/timing/Timer.h index 15a963265..89568b4f5 100644 --- a/src/core/timing/Timer.h +++ b/src/core/timing/Timer.h @@ -204,11 +204,11 @@ inline Timer<TP>::Timer() //********************************************************************************************************************** /*!\brief Constructor of the Timer class. // Initializes the timer with -// \param counter number of timing measurements already done -// \param min the minimum time of the measurements -// \param max the maximum time of the measurements -// \param total the total time of all measurements -// \param sumOfSquares each measurement time squared, then summed +// \param _counter number of timing measurements already done +// \param _min the minimum time of the measurements +// \param _max the maximum time of the measurements +// \param _total the total time of all measurements +// \param _sumOfSquares each measurement time squared, then summed */ template< typename TP> inline Timer<TP>::Timer( uint_t _counter, double _min, double _max, diff --git a/src/core/waLBerlaBuildInfo.in.cpp b/src/core/waLBerlaBuildInfo.in.cpp index 737aff558..65fa8887d 100644 --- a/src/core/waLBerlaBuildInfo.in.cpp +++ b/src/core/waLBerlaBuildInfo.in.cpp @@ -1,6 +1,6 @@ //====================================================================================================================== /*! - * \file waLBerlaBuildInfo.cpp + * \file waLBerlaBuildInfo.in.cpp * \brief Configured by CMake, contains information about the current build */ //====================================================================================================================== diff --git a/src/cuda/ExecutionTreeGPU.h b/src/cuda/ExecutionTreeGPU.h index 0b4e565d5..9c865378c 100644 --- a/src/cuda/ExecutionTreeGPU.h +++ b/src/cuda/ExecutionTreeGPU.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file TaskTree.h +//! \file ExecutionTreeGPU.h //! \ingroup cuda //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/cuda/FieldAccessor.h b/src/cuda/FieldAccessor.h index b4650ea57..c2c676d1d 100644 --- a/src/cuda/FieldAccessor.h +++ b/src/cuda/FieldAccessor.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file SimpleFieldAccessor.h +//! \file FieldAccessor.h //! \ingroup cuda //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/cuda/FieldIndexing.h b/src/cuda/FieldIndexing.h index 7ed089f4b..229d3b36b 100644 --- a/src/cuda/FieldIndexing.h +++ b/src/cuda/FieldIndexing.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file SimpleFieldIndexing.h +//! \file FieldIndexing.h //! \ingroup cuda //! \author Martin Bauer <martin.bauer@fau.de> //! \brief Indexing Scheme that executes all elements of inner coordinate within on thread block diff --git a/src/cuda/FieldIndexing.impl.h b/src/cuda/FieldIndexing.impl.h index 3c579cd4b..7acafcdbb 100644 --- a/src/cuda/FieldIndexing.impl.h +++ b/src/cuda/FieldIndexing.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file SimpleFieldIndexing.cpp +//! \file FieldIndexing.impl.h //! \ingroup cuda //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/cuda/FieldIndexing3D.impl.h b/src/cuda/FieldIndexing3D.impl.h index bfb7b0edd..8a3a0f230 100644 --- a/src/cuda/FieldIndexing3D.impl.h +++ b/src/cuda/FieldIndexing3D.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file FieldIndexing3D.cpp +//! \file FieldIndexing3D.impl.h //! \ingroup cuda //! \author Paulo Carvalho <prcjunior@inf.ufpr.br> // diff --git a/src/cuda/FieldIndexingXYZ.impl.h b/src/cuda/FieldIndexingXYZ.impl.h index c8ec561f9..6053e4ee8 100644 --- a/src/cuda/FieldIndexingXYZ.impl.h +++ b/src/cuda/FieldIndexingXYZ.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file FieldIndexingXYZ.cpp +//! \file FieldIndexingXYZ.impl.h //! \ingroup cuda //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/cuda/GPUCopy.h b/src/cuda/GPUCopy.h index a854068cd..775d705b3 100644 --- a/src/cuda/GPUCopy.h +++ b/src/cuda/GPUCopy.h @@ -40,9 +40,10 @@ namespace cuda { * \param src source buffer * \param dstOffset (x, y, z, f)-tuple containing the coordinate of the interval start point in the destination buffer * \param srcOffset (x, y, z, f)-tuple containing the coordinate of the interval start point in the source buffer - * \param dstAllocSizeY allocation size in y direction of the destination buffer - * \param srcAllocSizeY allocation size in y direction of the source buffer + * \param dstAllocSizeZ allocation size in z direction of the destination buffer + * \param srcAllocSizeZ allocation size in z direction of the source buffer * \param typeSize size of an f element + * \param intervalSize interval size * \param copyStream CUDA stream, if not NULL copy operations will be performed asynchronously *****************************************************************************************************************************/ void copyDevToDevFZYX( const cudaPitchedPtr& dst, const cudaPitchedPtr& src, @@ -62,6 +63,7 @@ void copyDevToDevFZYX( const cudaPitchedPtr& dst, const cudaPitchedPtr& src, * \param dstAllocSizeY allocation size in y direction of the destination buffer * \param srcAllocSizeY allocation size in y direction of the source buffer * \param typeSize size of an f element + * \param intervalSize interval size * \param copyStream CUDA stream, if not NULL copy operations will be performed asynchronously *****************************************************************************************************************************/ void copyDevToDevZYXF( const cudaPitchedPtr& dst, const cudaPitchedPtr& src, @@ -72,7 +74,7 @@ void copyDevToDevZYXF( const cudaPitchedPtr& dst, const cudaPitchedPtr& src, cudaStream_t copyStream ); //******************************************************************************************************************* -/*! Copy a 4D interval of a host buffer to a device buffer with fzyx memory layout. See copyDevToDevFZYX() for +/*! Copy a 4D interval of a host buffer to a device buffer with fzyx memory layout. See \ref copyDevToDevFZYX() for * parameter information. *******************************************************************************************************************/ void copyHostToDevFZYX( const cudaPitchedPtr& dst, unsigned char* src, @@ -83,7 +85,7 @@ void copyHostToDevFZYX( const cudaPitchedPtr& dst, unsigned char* src, cudaStream_t copyStream ); //******************************************************************************************************************* -/*! Copy a 4D interval of a host buffer to a device buffer with zyxf memory layout. See copyDevToDevZYXF() for +/*! Copy a 4D interval of a host buffer to a device buffer with zyxf memory layout. See \ref copyDevToDevZYXF() for * parameter information. *******************************************************************************************************************/ void copyHostToDevZYXF( const cudaPitchedPtr& dst, unsigned char* src, @@ -94,7 +96,7 @@ void copyHostToDevZYXF( const cudaPitchedPtr& dst, unsigned char* src, cudaStream_t copyStream ); //******************************************************************************************************************* -/*! Copy a 4D interval of a device buffer to a host buffer with fzyx memory layout. See copyDevToDevFZYX() for +/*! Copy a 4D interval of a device buffer to a host buffer with fzyx memory layout. See \ref copyDevToDevFZYX() for * parameter information. *******************************************************************************************************************/ void copyDevToHostFZYX( unsigned char* dst, const cudaPitchedPtr& src, @@ -105,7 +107,7 @@ void copyDevToHostFZYX( unsigned char* dst, const cudaPitchedPtr& src, cudaStream_t copyStream ); //******************************************************************************************************************* -/*! Copy a 4D interval of a device buffer to a host buffer with zyxf memory layout. See copyDevToDevZYXF() for +/*! Copy a 4D interval of a device buffer to a host buffer with zyxf memory layout. See \ref copyDevToDevZYXF() for * parameter information. *******************************************************************************************************************/ void copyDevToHostZYXF( unsigned char* dst, const cudaPitchedPtr& src, diff --git a/src/cuda/GPUField.impl.h b/src/cuda/GPUField.impl.h index 54c3b40cc..5dd3e5840 100644 --- a/src/cuda/GPUField.impl.h +++ b/src/cuda/GPUField.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file GPUField.cpp +//! \file GPUField.impl.h //! \ingroup cuda //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/cuda/HostFieldAllocator.h b/src/cuda/HostFieldAllocator.h index 0c08bfadb..7276c495d 100644 --- a/src/cuda/HostFieldAllocator.h +++ b/src/cuda/HostFieldAllocator.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file CudaHostFieldAllocator.h +//! \file HostFieldAllocator.h //! \ingroup cuda //! \author Martin Bauer <martin.bauer@fau.de> //! \brief Allocator that allocates a CPU! field using cudaHostAlloc diff --git a/src/cuda/communication/CustomMemoryBuffer.h b/src/cuda/communication/CustomMemoryBuffer.h index ddf475b1a..d0e8bdff9 100644 --- a/src/cuda/communication/CustomMemoryBuffer.h +++ b/src/cuda/communication/CustomMemoryBuffer.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BasicBuffer.h +//! \file CustomMemoryBuffer.h //! \ingroup cuda //! \author Martin Bauer <martin.bauer@fau.de> //! \brief Basic Buffer supporting different memory spaces diff --git a/src/cuda/communication/CustomMemoryBuffer.impl.h b/src/cuda/communication/CustomMemoryBuffer.impl.h index cfc5d8283..3d7715f89 100644 --- a/src/cuda/communication/CustomMemoryBuffer.impl.h +++ b/src/cuda/communication/CustomMemoryBuffer.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BasicBuffer.h +//! \file CustomMemoryBuffer.impl.h //! \ingroup cuda //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/executiontree/ExecutionTree.cpp b/src/executiontree/ExecutionTree.cpp index 346b089ec..3ceca45b9 100644 --- a/src/executiontree/ExecutionTree.cpp +++ b/src/executiontree/ExecutionTree.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file TaskTree.cpp +//! \file ExecutionTree.cpp //! \ingroup executiontree //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/executiontree/ExecutionTree.h b/src/executiontree/ExecutionTree.h index b9d39d798..131afc34c 100644 --- a/src/executiontree/ExecutionTree.h +++ b/src/executiontree/ExecutionTree.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file TaskTree.h +//! \file ExecutionTree.h //! \ingroup executiontree //! \author Martin Bauer <martin.bauer@fau.de> // @@ -57,7 +57,7 @@ template< typename FunctorType > class SharedSweep; /*! Creates a functor node around any callable object. The wrapped functor is copied. * - * \param any callable object. The object is copied - if its state has to be modified later, pass a shared_ptr to a functor instead + * \param t callable object. The object is copied - if its state has to be modified later, pass a shared_ptr to a functor instead * \param name optional name of the functor node * \param timingTree optional timing tree object to time all executions of this functor */ @@ -86,7 +86,7 @@ shared_ptr< Sequence > parallelSequence( std::initializer_list< IFunctionNodePtr /*! Note that runs its contents only every n'th call * * \param node task that is only run every n'th call - * \param name the interval i.e. "n" + * \param interval the interval i.e. "n" * \param onFirst if false the task is not run at the first call * \param startValue initial call counter */ diff --git a/src/executiontree/ExecutionTree.impl.h b/src/executiontree/ExecutionTree.impl.h index 8bdfb2bed..6ddb7c282 100644 --- a/src/executiontree/ExecutionTree.impl.h +++ b/src/executiontree/ExecutionTree.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file TaskTree.impl.h +//! \file ExecutionTree.impl.h //! \ingroup executiontree //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/executiontree/ExecutionTreeSweep.h b/src/executiontree/ExecutionTreeSweep.h index e450d9843..d1c6e05de 100644 --- a/src/executiontree/ExecutionTreeSweep.h +++ b/src/executiontree/ExecutionTreeSweep.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file TaskTree.h +//! \file ExecutionTreeSweep.h //! \ingroup executiontree //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/field/AddToStorage.h b/src/field/AddToStorage.h index 4999b1746..c60484bab 100644 --- a/src/field/AddToStorage.h +++ b/src/field/AddToStorage.h @@ -223,11 +223,9 @@ BlockDataID addToStorage( const shared_ptr< BlockStorage_T > & blocks, //********************************************************************************************************************** /*! Adds a copy of an existing field to BlockStorage * -* Template parameters: -* Field_T the type of the field that should be cloned ( and the type that is created ) -* BlockStorage_T the type of the BlockStorage ( will be deduced automatically ) +* \tparam Field_T the type of the field that should be cloned ( and the type that is created ) +* \tparam BlockStorage_T the type of the BlockStorage ( will be deduced automatically ) * -* Parameters: * \param blocks BlockStorage where the original field is stored and the new one is created * \param fieldToClone BlockDataID of the Field that is cloned * \param identifier name for new the field ( displayed in GUI and debugging functions ) @@ -253,11 +251,9 @@ BlockDataID addCloneToStorage( const shared_ptr< BlockStorage_T > & blocks, //********************************************************************************************************************** /*! Adds a flattened shallow copy of an existing field to BlockStorage * -* Template parameters: -* Field_T the type of the field that should be cloned and flattened -* BlockStorage_T the type of the BlockStorage ( will be deduced automatically ) +* \tparam Field_T the type of the field that should be cloned and flattened +* \tparam BlockStorage_T the type of the BlockStorage ( will be deduced automatically ) * -* Parameters: * \param blocks BlockStorage where the original field is stored and the new one is created * \param fieldToClone BlockDataID of the Field that is cloned * \param identifier name for new the field ( displayed in GUI and debugging functions ) diff --git a/src/field/CMakeDefs.in.h b/src/field/CMakeDefs.in.h index 2844dc4da..9a65511c5 100644 --- a/src/field/CMakeDefs.in.h +++ b/src/field/CMakeDefs.in.h @@ -1,6 +1,6 @@ //====================================================================================================================== /*! - * \file CMakeDefs.h + * \file CMakeDefs.in.h * \brief Definitions for field module configured by cmake */ //====================================================================================================================== diff --git a/src/field/Field.impl.h b/src/field/Field.impl.h index c5fec45c7..fc679c689 100644 --- a/src/field/Field.impl.h +++ b/src/field/Field.impl.h @@ -54,10 +54,10 @@ namespace field { //******************************************************************************************************************* /*!Creates an uninitialized field of given size * - * \param xSize size of x dimension - * \param ySize size of y dimension - * \param zSize size of z dimension - * \param layout memory layout of the field (see Field::Layout) + * \param _xSize size of x dimension + * \param _ySize size of y dimension + * \param _zSize size of z dimension + * \param l memory layout of the field (see Field::Layout) * \param alloc class that describes how to allocate memory for the field, see FieldAllocator *******************************************************************************************************************/ template<typename T, uint_t fSize_> @@ -72,11 +72,11 @@ namespace field { //******************************************************************************************************************* /*! Creates a field and initializes it with constant * - * \param xSize size of x dimension - * \param ySize size of y dimension - * \param zSize size of z dimension + * \param _xSize size of x dimension + * \param _ySize size of y dimension + * \param _zSize size of z dimension * \param initVal every element of the field is set to initVal - * \param layout memory layout of the field (see Field::Layout) + * \param l memory layout of the field (see Field::Layout) * \param alloc class that describes how to allocate memory for the field, see FieldAllocator *******************************************************************************************************************/ template<typename T, uint_t fSize_> @@ -92,11 +92,11 @@ namespace field { //******************************************************************************************************************* /*! Creates a field and initializes f coordinate with vector values * - * \param xSize size of x dimension - * \param ySize size of y dimension - * \param zSize size of z dimension + * \param _xSize size of x dimension + * \param _ySize size of y dimension + * \param _zSize size of z dimension * \param fValues initializes f coordinate with values from vector (see set(std::vector&) ) - * \param layout memory layout of the field (see Field::Layout) + * \param l memory layout of the field (see Field::Layout) * \param alloc class that describes how to allocate memory for the field, see FieldAllocator *******************************************************************************************************************/ template<typename T, uint_t fSize_> @@ -114,6 +114,9 @@ namespace field { /*! Deletes all stored data, and resizes the field * * The resized field is uninitialized. + * \param _xSize size of x dimension + * \param _ySize size of y dimension + * \param _zSize size of z dimension *******************************************************************************************************************/ template<typename T, uint_t fSize_> void Field<T,fSize_>::resize( uint_t _xSize, uint_t _ySize, uint_t _zSize ) @@ -294,10 +297,10 @@ namespace field { * Must be called exactly once! This is automatically called by all constructors * that take at least one argument * - * \param xSize size of x dimension - * \param ySize size of y dimension - * \param zSize size of z dimension - * \param layout memory layout of the field (see Field::Layout) + * \param _xSize size of x dimension + * \param _ySize size of y dimension + * \param _zSize size of z dimension + * \param l memory layout of the field (see Field::Layout) * \param alloc the allocator to use. If a NULL shared pointer is given, a sensible default is selected, * depending on layout * \param innerGhostLayerSizeForAlignedAlloc @@ -1082,8 +1085,12 @@ namespace field { * This is used for example in the constructor of the GhostLayerField * * Internally this is implementing by adding an offset to the values_ pointer, and by adapting the size_ members. - * \param xOff The x coordinate that is afterwards mapped to zero - * \param xs The new size of the x coordinate. Has to be smaller than (old xSize())-xOff + * \param xOffset The x coordinate that is afterwards mapped to zero + * \param xs The new size of the x coordinate. Has to be smaller than (old xSize())-xOffset + * \param yOffset The y coordinate that is afterwards mapped to zero + * \param ys The new size of the y coordinate. Has to be smaller than (old ySize())-yOffset + * \param zOffset The z coordinate that is afterwards mapped to zero + * \param zs The new size of the z coordinate. Has to be smaller than (old zSize())-zOffset *******************************************************************************************************************/ template<typename T, uint_t fSize_> void Field<T,fSize_>::setOffsets(uint_t xOffset, uint_t xs, diff --git a/src/field/FlagField.impl.h b/src/field/FlagField.impl.h index 4e32e312c..b765323a9 100644 --- a/src/field/FlagField.impl.h +++ b/src/field/FlagField.impl.h @@ -48,9 +48,9 @@ namespace field { //******************************************************************************************************************* /*!\brief Constructor. Initializes field with 0 (no flags set). * - * \param xSize size of x dimension without ghost layers - * \param ySize size of y dimension without ghost layers - * \param zSize size of z dimension without ghost layers + * \param xs size of x dimension without ghost layers + * \param ys size of y dimension without ghost layers + * \param zs size of z dimension without ghost layers * \param gl number of ghost layers * \param alloc class that describes how to allocate memory for the field, see FieldAllocator *******************************************************************************************************************/ @@ -139,8 +139,8 @@ namespace field { //******************************************************************************************************************* /*!\brief Adds every (inner) cell where at least all bits of mask are set to the CellVector (in inner coordinates) * - * \param mask [in] bit mask. Test if a cell is added: (content & mask) == true - * \param cv [out] cell vector where the cells are added to, in inner coordinates + * \param[in] mask bit mask. Test if a cell is added: (content & mask) == true + * \param[out] cv cell vector where the cells are added to, in inner coordinates *******************************************************************************************************************/ template<typename T> void FlagField<T>::getCellsWhereMaskIsSet(T mask, CellVector & cv) const @@ -195,7 +195,7 @@ namespace field { //******************************************************************************************************************* /*!\brief Registers a flag. Uses the next free bit in the field. * - * \param uid uid of the flag + * \param uid UID for the flag * \return Mask, that has exactly one bit set to one. *******************************************************************************************************************/ template<typename T> @@ -230,7 +230,7 @@ namespace field { * * If bitNr is not important use registerFlag(name) which assigns the next free bit to the flag. * - * \param name string identifier for the flag + * \param uid UID for the flag * \param bitNr The bit nr associated with the flag (NOT the mask!). Has to be smaller than sizeof(flag_type)*8 * There exists also a function where this information is not needed, and the next free bit is used. * \return Mask, that has the given bit set to one i.e. 1 << bitNr @@ -484,7 +484,8 @@ namespace field { //****************************************************************************************************************** /*!\brief Ores the neighborhood of the specified stencil and checks whether the bits of mask are set * - * \param mask [in] bit mask. Test if a cell is added: (content & mask) == true + * \param[in] i field pointer. + * \param[in] mask bit mask. Test if a cell is added: (content & mask) == true ******************************************************************************************************************/ template<class Sten, typename FieldPtrOrIterator> inline bool isFlagInNeighborhood(const FieldPtrOrIterator & i, typename FieldPtrOrIterator::value_type mask) @@ -507,6 +508,7 @@ namespace field { //****************************************************************************************************************** /*!\brief Ores the neighborhood of the specified stencil and returns mask + * \param[in] i field pointer. ******************************************************************************************************************/ template<class Sten, typename FieldPtrOrIterator> inline typename std::remove_const<typename FieldPtrOrIterator::value_type>::type diff --git a/src/field/GhostLayerField.impl.h b/src/field/GhostLayerField.impl.h index 8e122c36a..d594274e7 100644 --- a/src/field/GhostLayerField.impl.h +++ b/src/field/GhostLayerField.impl.h @@ -53,11 +53,11 @@ namespace field { //******************************************************************************************************************* /*!\brief Creates an uninitialized field of given size * - * \param xSize size of x dimension without ghost layers - * \param ySize size of y dimension without ghost layers - * \param zSize size of z dimension without ghost layers + * \param _xSize size of x dimension without ghost layers + * \param _ySize size of y dimension without ghost layers + * \param _zSize size of z dimension without ghost layers * \param gl number of ghost layers - * \param layout memory layout of the field (see Layout) + * \param l memory layout of the field (see Layout) * \param alloc class that describes how to allocate memory for the field, see FieldAllocator *******************************************************************************************************************/ template<typename T, uint_t fSize_> @@ -71,12 +71,12 @@ namespace field { //******************************************************************************************************************* /*!\brief Creates a field and initializes it with constant value * - * \param xSize size of x dimension without ghost layers - * \param ySize size of y dimension without ghost layers - * \param zSize size of z dimension without ghost layers + * \param _xSize size of x dimension without ghost layers + * \param _ySize size of y dimension without ghost layers + * \param _zSize size of z dimension without ghost layers * \param gl number of ghost layers * \param initVal every element of the field is set to initVal (also ghost layers) - * \param layout memory layout of the field (see Layout) + * \param l memory layout of the field (see Layout) * \param alloc class that describes how to allocate memory for the field, see FieldAllocator *******************************************************************************************************************/ template<typename T, uint_t fSize_> @@ -92,12 +92,12 @@ namespace field { //******************************************************************************************************************* /*!\brief Creates a field and initializes f coordinate with vector values * - * \param xSize size of x dimension - * \param ySize size of y dimension - * \param zSize size of z dimension + * \param _xSize size of x dimension + * \param _ySize size of y dimension + * \param _zSize size of z dimension * \param gl number of ghost layers * \param fValues initializes f coordinate with values from vector (see set(std::vector&) ) also ghost layers - * \param layout memory layout of the field (see Layout) + * \param l memory layout of the field (see Layout) * \param alloc class that describes how to allocate memory for the field, see FieldAllocator *******************************************************************************************************************/ template<typename T, uint_t fSize_> @@ -116,11 +116,11 @@ namespace field { * * Is automatically called by constructors that take at least one argument * - * \param xSize size of x dimension without ghost layers - * \param ySize size of y dimension without ghost layers - * \param zSize size of z dimension without ghost layers + * \param _xSize size of x dimension without ghost layers + * \param _ySize size of y dimension without ghost layers + * \param _zSize size of z dimension without ghost layers * \param gl number of ghost layers - * \param layout memory layout of the field (see Layout) + * \param l memory layout of the field (see Layout) * \param alloc class that describes how to allocate memory for the field, see FieldAllocator *******************************************************************************************************************/ template<typename T, uint_t fSize_> diff --git a/src/field/GhostRegions.h b/src/field/GhostRegions.h index 359163aed..7745968ac 100644 --- a/src/field/GhostRegions.h +++ b/src/field/GhostRegions.h @@ -31,6 +31,7 @@ namespace field { //******************************************************************************************************************* /*!\brief Constructs CellInterval containing the ghost region in the specified direction * + * \param f field * \param d direction of the ghost layer For W,E,N,S,T,B a slice is returned * for NW, NE, .. an edge is returned * for TBE, TNW, ... a corner ( single cell ) is returned @@ -72,6 +73,7 @@ CellInterval getGhostRegion( const GhostLayerField_T & f, stencil::Direction d, /*!\brief Constructs CellInterval containing the last slice before the ghost layer begins * for a given direction. * + * \param f field * \param d direction of the border . For W,E,N,S,T,B a slice is returned * for NW, NE, .. an edge is returned * for TBE, TNW, ... a corner ( single cell ) is returned diff --git a/src/field/StabilityChecker.h b/src/field/StabilityChecker.h index fbbc530e7..dde22f113 100644 --- a/src/field/StabilityChecker.h +++ b/src/field/StabilityChecker.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file StabilityCheckerer.h +//! \file StabilityChecker.h //! \ingroup field //! \author Florian Schornbaum <florian.schornbaum@fau.de> // diff --git a/src/field/allocation/FieldAllocator.h b/src/field/allocation/FieldAllocator.h index 781cda4bc..7a3164ede 100644 --- a/src/field/allocation/FieldAllocator.h +++ b/src/field/allocation/FieldAllocator.h @@ -62,12 +62,14 @@ namespace field { /** * \brief Allocate memory for a field of given sizes and initializes reference counter with one * - * \param size* The size of the field. size0*size1*size2*size*3 is the minimum amount of + * \param size0,size1,size2,size3 + * The size of the field. size0*size1*size2*size3 is the minimum amount of * memory that has to be allocated. size0 is the size of the outermost (slowest) * coordinate, size3 the size of the fastest. * - * \param allocSize* Output parameters. The actual size of the allocation may be bigger. Here - * allocSize can be bigger than size if alignment >0. There is no allocSize0, + * \param allocSize1,allocSize2,allocSize3 + * Output parameters. The actual size of the allocation may be bigger. Here + * allocSize* can be bigger than size* if alignment >0. There is no allocSize0, * since extra allocations (padding) for the outer coordinate do not make sense. */ T * allocate ( uint_t size0, uint_t size1, uint_t size2, uint_t size3, @@ -116,7 +118,7 @@ namespace field { /** * \brief Increments the reference count for the given pointer * - * \param allocatedPointer a pointer that was returned by the allocate function + * \param mem a pointer that was returned by the allocate function * * The reference counter is the number of field objects that currently use the allocated * memory region @@ -141,11 +143,11 @@ namespace field { /** * \brief Decrements the reference count for the given pointer * - * \param allocatedPointer a pointer that was returned by the allocate function + * \param mem a pointer that was returned by the allocate function * * A memory region is freed only when the reference count is zero. - * \return true if memory was freed, - * false if some other field still uses the memory + * \return \a true if memory was freed, + * \a false if some other field still uses the memory */ bool decrementReferenceCount( T * mem ) { diff --git a/src/field/communication/ReducePackInfo.h b/src/field/communication/ReducePackInfo.h index 532b43724..71bd939fd 100644 --- a/src/field/communication/ReducePackInfo.h +++ b/src/field/communication/ReducePackInfo.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file ReduceFieldPackInfo.h +//! \file ReducePackInfo.h //! \ingroup field //! \author Matthias Markl <matthias.markl@fau.de> //! \brief Stores/reduces ghost layers to/from a communication buffer diff --git a/src/field/communication/StencilRestrictedPackInfo.h b/src/field/communication/StencilRestrictedPackInfo.h index 45527cadf..b82050340 100644 --- a/src/field/communication/StencilRestrictedPackInfo.h +++ b/src/field/communication/StencilRestrictedPackInfo.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file PdfFieldPackInfo.h +//! \file StencilRestrictedPackInfo.h //! \ingroup lbm //! \author Martin Bauer <martin.bauer@fau.de> //! \author Florian Schornbaum <florian.schornbaum@fau.de> diff --git a/src/field/iterators/FieldIterator.impl.h b/src/field/iterators/FieldIterator.impl.h index d2184e9a8..dad6841f9 100644 --- a/src/field/iterators/FieldIterator.impl.h +++ b/src/field/iterators/FieldIterator.impl.h @@ -304,6 +304,7 @@ inline bool FieldIterator<T,fs>::operator!=( const FieldIterator<T,fs>& it ) con //********************************************************************************************************************** /*!\brief Neighbor access relative to current position * \param d Direction enumeration which defines deltas for x,y,z + * \param cf Delta for f **********************************************************************************************************************/ template <typename T, uint_t fs> inline T & FieldIterator<T,fs>::neighbor( stencil::Direction d, cell_idx_t cf ) const @@ -315,6 +316,8 @@ inline T & FieldIterator<T,fs>::neighbor( stencil::Direction d, cell_idx_t cf ) //********************************************************************************************************************** /*!\brief uint_t variant of above function + * \param d Direction enumeration which defines deltas for x,y,z + * \param cf Delta for f **********************************************************************************************************************/ template <typename T, uint_t fs> inline T & FieldIterator<T,fs>::neighbor( stencil::Direction d, uint_t cf ) const @@ -325,7 +328,10 @@ inline T & FieldIterator<T,fs>::neighbor( stencil::Direction d, uint_t cf ) cons //********************************************************************************************************************** /*!\brief Neighbor access relative to current position - * \param d Direction enumeration which defines deltas for x,y,z,f + * \param cx Delta for x + * \param cy Delta for y + * \param cz Delta for z + * \param cf Delta for f **********************************************************************************************************************/ template <typename T, uint_t fs> inline T & FieldIterator<T,fs>::neighbor( cell_idx_t cx, cell_idx_t cy, cell_idx_t cz, cell_idx_t cf ) const @@ -346,6 +352,10 @@ inline T & FieldIterator<T,fs>::neighbor( cell_idx_t cx, cell_idx_t cy, cell_idx //********************************************************************************************************************** /*!\brief Neighbor variant that takes unsigned int as f parameter, * needed since the stencil toIdx() is an unsigned int + * \param cx Delta for x + * \param cy Delta for y + * \param cz Delta for z + * \param cf Delta for f **********************************************************************************************************************/ template <typename T, uint_t fs> inline T & FieldIterator<T,fs>::neighbor( cell_idx_t cx, cell_idx_t cy, cell_idx_t cz, uint_t cf ) const @@ -358,6 +368,7 @@ inline T & FieldIterator<T,fs>::neighbor( cell_idx_t cx, cell_idx_t cy, cell_idx //********************************************************************************************************************** /*!\brief For beginXYZ iterators, one often needs a specific f * Assumes that iterator stands at f==0 + * \param cf Delta for f **********************************************************************************************************************/ template <typename T, uint_t fs> inline T & FieldIterator<T,fs>::getF( cell_idx_t cf ) const @@ -373,6 +384,7 @@ inline T & FieldIterator<T,fs>::getF( cell_idx_t cf ) const //********************************************************************************************************************** /*!\brief Equivalent to neighbor(cell_idx_t) see above. * Takes an uint_t instead a cell_idx_t, since stencil::toIndex() returns uint_t + * \param cf Delta for f **********************************************************************************************************************/ template <typename T, uint_t fs> inline T & FieldIterator<T,fs>::getF( uint_t cf ) const diff --git a/src/field/vtk/VTKWriter.h b/src/field/vtk/VTKWriter.h index 513b920e1..9b2232908 100644 --- a/src/field/vtk/VTKWriter.h +++ b/src/field/vtk/VTKWriter.h @@ -60,8 +60,8 @@ namespace field { * \param continuousNumbering important when writeFrequency > 1, if true the simulation steps are numbered continuously * otherwise they are numbered after the timestep * \param binary switch for binary output -* \param litteEndian byte order -* \param simultaneousIOOps number of simultaneous IO operations, 0 means all processes write concurrently +* \param littleEndian byte order +* \param simultaneousIOOperations number of simultaneous IO operations, 0 means all processes write concurrently * limiting the number of simultaneous IO operations makes sense for huge number of processes * in order to not overload the file system * \param requiredStates see selectable concept diff --git a/src/gather/CellGatherPackInfo.h b/src/gather/CellGatherPackInfo.h index e12e5ab6f..81d2f0018 100644 --- a/src/gather/CellGatherPackInfo.h +++ b/src/gather/CellGatherPackInfo.h @@ -64,7 +64,7 @@ public: * * \param bs StructuredBlockStorage containing the field * \param fieldID BlockDataID of the field that should be collected - * \param container Container of cells in global coordinates, order of cells is important for output + * \param containerOfGlobalCells Container of cells in global coordinates, order of cells is important for output * \param dp data processor where gathered data is delivered to */ //******************************************************************************************************************* diff --git a/src/geometry/bodies/Ellipsoid.h b/src/geometry/bodies/Ellipsoid.h index 0dbaf4b0a..12b48ca32 100644 --- a/src/geometry/bodies/Ellipsoid.h +++ b/src/geometry/bodies/Ellipsoid.h @@ -50,7 +50,7 @@ namespace geometry { /*************************************************************************************************************//** * Ellipsoid constructor * - * \param midpoin t midpoint of the ellipsoid + * \param midpoint midpoint of the ellipsoid * \param axis1 the first semi-axis of the ellipsoid ( associated with radius1 ) * not required to be normalized, is normalized internally * \param axis2 second semi-axis (must not be parallel to axis1 ) should ideally be perpendicular to axis1 diff --git a/src/geometry/initializer/BoundaryFromImage.impl.h b/src/geometry/initializer/BoundaryFromImage.impl.h index 7b75bdf5c..0284887aa 100644 --- a/src/geometry/initializer/BoundaryFromImage.impl.h +++ b/src/geometry/initializer/BoundaryFromImage.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BoundaryFromImage.impl +//! \file BoundaryFromImage.impl.h //! \ingroup geometry //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/geometry/initializer/BoundarySetter.h b/src/geometry/initializer/BoundarySetter.h index efbc38c31..e793b505e 100644 --- a/src/geometry/initializer/BoundarySetter.h +++ b/src/geometry/initializer/BoundarySetter.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Helper.h +//! \file BoundarySetter.h //! \ingroup geometry //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/geometry/initializer/BoundarySetterFlagFieldSpecialization.h b/src/geometry/initializer/BoundarySetterFlagFieldSpecialization.h index f731a37f0..8e3ee37ee 100644 --- a/src/geometry/initializer/BoundarySetterFlagFieldSpecialization.h +++ b/src/geometry/initializer/BoundarySetterFlagFieldSpecialization.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Helper.h +//! \file BoundarySetterFlagFieldSpecialization.h //! \ingroup geometry //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/geometry/initializer/ScalarFieldFromBody.h b/src/geometry/initializer/ScalarFieldFromBody.h index 617097ad8..49f4bf117 100644 --- a/src/geometry/initializer/ScalarFieldFromBody.h +++ b/src/geometry/initializer/ScalarFieldFromBody.h @@ -107,11 +107,10 @@ namespace initializer { * \param body The body object - has to implement either overlapFraction(...), or contains(...) * see BodyOverlapFunctions for detailed body concept * \param value The value to set on the matched cells in the field. - * \param parser A function parser which will have the variables x,y,z bound before it is evaluated * \param addOrSet If true, the value is added to scalar field * If false, the value is set on the scalar field. * \param id If operating on a vector of fields, which field to treat. Zero otherwise. - + * * Supported bodies are Sphere, Ellipsoid, AABB. * To add a new supported body implement concept defined in BodyOverlapFunctions.h, and * add an explicit template instantiation in ScalarFieldFromBody.cpp for the new body. @@ -119,6 +118,21 @@ namespace initializer { *****************************************************************************************************************/ template<typename Body> void init( const Body & body, Value_T value, bool addOrSet, std::vector<BlockDataID>::size_type id = 0 ); + /*************************************************************************************************************//** + * Sets a body on the scalar field + * + * \param body The body object - has to implement either overlapFraction(...), or contains(...) + * see BodyOverlapFunctions for detailed body concept + * \param parser A function parser which will have the variables x,y,z bound before it is evaluated + * \param addOrSet If true, the value is added to scalar field + * If false, the value is set on the scalar field. + * \param id If operating on a vector of fields, which field to treat. Zero otherwise. + * + * Supported bodies are Sphere, Ellipsoid, AABB. + * To add a new supported body implement concept defined in BodyOverlapFunctions.h, and + * add an explicit template instantiation in ScalarFieldFromBody.cpp for the new body. + * + *****************************************************************************************************************/ template<typename Body> void init( const Body & body, math::FunctionParser & parser, bool addOrSet, std::vector<BlockDataID>::size_type id = 0 ); diff --git a/src/geometry/initializer/ScalarFieldFromBody.impl.h b/src/geometry/initializer/ScalarFieldFromBody.impl.h index fc4042954..7c96eea77 100644 --- a/src/geometry/initializer/ScalarFieldFromBody.impl.h +++ b/src/geometry/initializer/ScalarFieldFromBody.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file ScalarFieldFromBody.cpp +//! \file ScalarFieldFromBody.impl.h //! \ingroup geometry //! \author Michael Kuron <mkuron@icp.uni-stuttgart.de> // diff --git a/src/geometry/initializer/ScalarFieldFromCellInterval.h b/src/geometry/initializer/ScalarFieldFromCellInterval.h index 4011a9c36..9832b0989 100644 --- a/src/geometry/initializer/ScalarFieldFromCellInterval.h +++ b/src/geometry/initializer/ScalarFieldFromCellInterval.h @@ -65,7 +65,7 @@ class ScalarFieldFromCellInterval : public Initializer public: typedef typename Field_T::value_type Value_T; - + ScalarFieldFromCellInterval( StructuredBlockStorage & blocks, BlockDataID fieldId ) : ScalarFieldFromCellInterval(blocks, std::vector<BlockDataID>(1, fieldId)) {} @@ -86,10 +86,16 @@ public: * * \param interval the cell interval * \param value which value to set in the field for all cells in the interval - * \param parser a function parser which will have the variables x,y,z bound before it is evaluated * \param id which field to operate on (if operating on a vector of fields), defaults to 0 *****************************************************************************************************************/ void init( const CellInterval & interval, Value_T value, std::vector<BlockDataID>::size_type id = 0 ); + /*************************************************************************************************************//** + * Function for manually setting a scalar field on a CellInterval + * + * \param interval the cell interval + * \param parser a function parser which will have the variables x,y,z bound before it is evaluated + * \param id which field to operate on (if operating on a vector of fields), defaults to 0 + *****************************************************************************************************************/ void init( const CellInterval & interval, math::FunctionParser & parser, std::vector<BlockDataID>::size_type id = 0 ); diff --git a/src/geometry/mesh/TriangleMeshIO.h b/src/geometry/mesh/TriangleMeshIO.h index ff64209e8..b6ba35ad3 100644 --- a/src/geometry/mesh/TriangleMeshIO.h +++ b/src/geometry/mesh/TriangleMeshIO.h @@ -35,7 +35,7 @@ namespace geometry { * * Mesh format is detected by file ending. * - * \param fileName Filename of mesh. Supported formats are obj, pov and off. Format is detected + * \param meshFilename Filename of mesh. Supported formats are obj, pov and off. Format is detected * by file ending * \param mesh object where the mesh is stored, if the given mesh is not * empty, all contents are cleared @@ -47,7 +47,7 @@ namespace geometry { * * Mesh format is detected by file ending. * - * \param fileName Filename of mesh. Supported formats are obj, pov and off. Format is detected + * \param meshFilename Filename of mesh. Supported formats are obj, pov and off. Format is detected * by file ending * \param mesh object where the mesh is read from */ @@ -58,7 +58,7 @@ namespace geometry { * * Mesh format is detected by file ending. * - * \param fileName Filename of mesh. Supported formats are obj, pov and off. Format is detected + * \param meshFilename Filename of mesh. Supported formats are obj, pov and off. Format is detected * by file ending * \param mesh object where the mesh is stored, if the given mesh is not * empty, all contents are cleared @@ -72,7 +72,7 @@ namespace geometry { * * Mesh format is detected by file ending. * - * \param fileName Filename of mesh. Supported formats are obj, pov and off. Format is detected + * \param meshFilename Filename of mesh. Supported formats are obj, pov and off. Format is detected * by file ending * \param mesh object where the mesh is read from */ diff --git a/src/geometry/structured/BasicVoxelFileReader.impl.h b/src/geometry/structured/BasicVoxelFileReader.impl.h index a387c92fa..7c02ed1f8 100644 --- a/src/geometry/structured/BasicVoxelFileReader.impl.h +++ b/src/geometry/structured/BasicVoxelFileReader.impl.h @@ -49,7 +49,7 @@ BasicVoxelFileReader<T>::BasicVoxelFileReader() : xSize_(0), ySize_(0), zSize_(0 /*******************************************************************************************************************//** * \brief Opens an existing geometry file. * - * \param filename Name (path) of the file. + * \param _filename Name (path) of the file. * * \throws std::runtime_error on I/O errors. * @@ -73,11 +73,11 @@ BasicVoxelFileReader<T>::BasicVoxelFileReader( const std::string & _filename) /*******************************************************************************************************************//** * \brief Creates a new geometry file with extends xSize x ySize x zSize. * - * \param filename Name (path) of the file. - * \param xSize Extend of the geometry file in x direction. - * \param ySize Extend of the geometry file in y direction. - * \param zSize Extend of the geometry file in z direction. - * \param value The value the cells are initialized with. Defaults to T(). + * \param _filename Name (path) of the file. + * \param _xSize Extend of the geometry file in x direction. + * \param _ySize Extend of the geometry file in y direction. + * \param _zSize Extend of the geometry file in z direction. + * \param value The value the cells are initialized with. Defaults to T(). * * \throws std::runtime_error on I/O errors. * @@ -101,12 +101,12 @@ BasicVoxelFileReader<T>::BasicVoxelFileReader( const std::string & _filename, st /*******************************************************************************************************************//** * \brief Creates a new geometry file with extends xSize x ySize x zSize. * - * \param filename Name (path) of the file. - * \param xSize Extend of the geometry file in x direction. - * \param ySize Extend of the geometry file in y direction. - * \param zSize Extend of the geometry file in z direction. - * \param values An array of size xSize * ySize * zSize with the values to initialize the - * geometry file with. + * \param _filename Name (path) of the file. + * \param _xSize Extend of the geometry file in x direction. + * \param _ySize Extend of the geometry file in y direction. + * \param _zSize Extend of the geometry file in z direction. + * \param values An array of size xSize * ySize * zSize with the values to initialize the + * geometry file with. * * \throws std::runtime_error on I/O errors. * @@ -145,9 +145,9 @@ BasicVoxelFileReader<T>::~BasicVoxelFileReader() /*******************************************************************************************************************//** * \brief Opens an existing geometry file. * -* An already opened file gets closed beforehand. +* An already opened file gets closed beforehand. * -* \param filename Name (path) of the file. +* \param _filename Name (path) of the file. * * \throws std::runtime_error on I/O errors. * \throws std::runtime_error if the loaded geometry file's format is corrupt @@ -223,11 +223,11 @@ void BasicVoxelFileReader<T>::open( const std::string & _filename ) * * An already opened file gets closed beforehand. * - * \param filename Name (path) of the file. - * \param xSize Extend of the geometry file in x direction. - * \param ySize Extend of the geometry file in y direction. - * \param zSize Extend of the geometry file in z direction. - * \param value The value the cells are initialized with. Defaults to T(). + * \param _filename Name (path) of the file. + * \param _xSize Extend of the geometry file in x direction. + * \param _ySize Extend of the geometry file in y direction. + * \param _zSize Extend of the geometry file in z direction. + * \param value The value the cells are initialized with. Defaults to T(). * * \throws std::runtime_error on I/O errors. * @@ -296,12 +296,12 @@ void BasicVoxelFileReader<T>::create( const std::string & _filename, std::size_t * * An already opened file gets closed beforehand. * - * \param filename Name (path) of the file. - * \param xSize Extend of the geometry file in x direction. - * \param ySize Extend of the geometry file in y direction. - * \param zSize Extend of the geometry file in z direction. - * \param values An array of size xSize * ySize * zSize with the values to initialize the - * geometry file with. + * \param _filename Name (path) of the file. + * \param _xSize Extend of the geometry file in x direction. + * \param _ySize Extend of the geometry file in y direction. + * \param _zSize Extend of the geometry file in z direction. + * \param values An array of size xSize * ySize * zSize with the values to initialize the + * geometry file with. * * \throws std::runtime_error on I/O errors. * @@ -465,7 +465,7 @@ std::size_t BasicVoxelFileReader<T>::numCells() const * * \param cellAABB The axis-aligned bounding box of the block of data to be read. * \param [out] data The vector the read data is stored to. The Storage order is zyx. (Meaning - * your innermost loop should iterate over x) + * your innermost loop should iterate over x) * * \throws std::runtime_error on I/O errors. * @@ -522,7 +522,7 @@ void BasicVoxelFileReader<T>::read( const CellAABB & cellAABB, std::vector<T> & * * \param cellAABB The axis-aligned bounding box of the block of data to be written. * \param data The vector holding the data to bw written to the geometry file. The Storage - * order is zyx. (Meaning your innermost loop should iterate over x) + * order is zyx. (Meaning your innermost loop should iterate over x) * * \throws std::runtime_error on I/O errors. * diff --git a/src/geometry/structured/BinaryRawFile.cpp b/src/geometry/structured/BinaryRawFile.cpp index 5b4c81256..efc472b4c 100644 --- a/src/geometry/structured/BinaryRawFile.cpp +++ b/src/geometry/structured/BinaryRawFile.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BinaryRawFileReader.cpp +//! \file BinaryRawFile.cpp //! \ingroup geometry //! \author Christian Godenschwager <christian.godenschwager@fau.de> // diff --git a/src/geometry/structured/BinaryRawFile.h b/src/geometry/structured/BinaryRawFile.h index 8a9e69346..2c0421783 100644 --- a/src/geometry/structured/BinaryRawFile.h +++ b/src/geometry/structured/BinaryRawFile.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BinaryRawFileReader.h +//! \file BinaryRawFile.h //! \ingroup geometry //! \author Christian Godenschwager <christian.godenschwager@fau.de> // diff --git a/src/geometry/structured/VoxelFileReader.impl.h b/src/geometry/structured/VoxelFileReader.impl.h index e91b75357..8f64c77ca 100644 --- a/src/geometry/structured/VoxelFileReader.impl.h +++ b/src/geometry/structured/VoxelFileReader.impl.h @@ -41,7 +41,7 @@ catch( std::exception & e) { WALBERLA_ABORT( e.what() ); } /*******************************************************************************************************************//** * \brief Opens an existing geometry file. * - * \param filename Name (path) of the file. + * \param _filename Name (path) of the file. * * \post isOpen() == true **********************************************************************************************************************/ @@ -53,11 +53,11 @@ catch( std::exception & e) { WALBERLA_ABORT( e.what() ); } /*******************************************************************************************************************//** * \brief Creates a new geometry file with extends xSize x ySize x zSize. * - * \param filename Name (path) of the file. - * \param xSize Extend of the geometry file in x direction. - * \param ySize Extend of the geometry file in y direction. - * \param zSize Extend of the geometry file in z direction. - * \param value The value the cells are initialized with. Defaults to T(). + * \param _filename Name (path) of the file. + * \param _xSize Extend of the geometry file in x direction. + * \param _ySize Extend of the geometry file in y direction. + * \param _zSize Extend of the geometry file in z direction. + * \param value The value the cells are initialized with. Defaults to T(). * * \post isOpen() == true **********************************************************************************************************************/ @@ -73,12 +73,12 @@ catch( std::exception & e) { WALBERLA_ABORT( e.what() ); } /*******************************************************************************************************************//** * \brief Creates a new geometry file with extends xSize x ySize x zSize. * -* \param filename Name (path) of the file. -* \param xSize Extend of the geometry file in x direction. -* \param ySize Extend of the geometry file in y direction. -* \param zSize Extend of the geometry file in z direction. -* \param values An array of size xSize * ySize * zSize with the values to initialize the -* geometry file with. +* \param _filename Name (path) of the file. +* \param _xSize Extend of the geometry file in x direction. +* \param _ySize Extend of the geometry file in y direction. +* \param _zSize Extend of the geometry file in z direction. +* \param values An array of size xSize * ySize * zSize with the values to initialize the +* geometry file with. * * \pre values != nullptr * @@ -96,9 +96,9 @@ catch( std::exception & e) { WALBERLA_ABORT( e.what() ); } /*******************************************************************************************************************//** * \brief Opens an existing geometry file. * -* An already opened file gets closed beforehand. +* An already opened file gets closed beforehand. * -* \param filename Name (path) of the file. +* \param _filename Name (path) of the file. * * \post isOpen() == true **********************************************************************************************************************/ @@ -117,11 +117,11 @@ void VoxelFileReader<T>::open( const std::string & _filename ) * * An already opened file gets closed beforehand. * - * \param filename Name (path) of the file. - * \param xSize Extend of the geometry file in x direction. - * \param ySize Extend of the geometry file in y direction. - * \param zSize Extend of the geometry file in z direction. - * \param value The value the cells are initialized with. Defaults to T(). + * \param _filename Name (path) of the file. + * \param _xSize Extend of the geometry file in x direction. + * \param _ySize Extend of the geometry file in y direction. + * \param _zSize Extend of the geometry file in z direction. + * \param value The value the cells are initialized with. Defaults to T(). * * \post isOpen() == true **********************************************************************************************************************/ @@ -140,12 +140,12 @@ void VoxelFileReader<T>::create( const std::string & _filename, uint_t _xSize, u * * An already opened file gets closed beforehand. * - * \param filename Name (path) of the file. - * \param xSize Extend of the geometry file in x direction. - * \param ySize Extend of the geometry file in y direction. - * \param zSize Extend of the geometry file in z direction. - * \param values An array of size xSize * ySize * zSize with the values to initialize the - * geometry file with. + * \param _filename Name (path) of the file. + * \param _xSize Extend of the geometry file in x direction. + * \param _ySize Extend of the geometry file in y direction. + * \param _zSize Extend of the geometry file in z direction. + * \param values An array of size xSize * ySize * zSize with the values to initialize the + * geometry file with. * * \pre values != nullptr * @@ -259,7 +259,7 @@ uint_t VoxelFileReader<T>::zSize() const * * \param cellInterval The axis-aligned bounding box of the block of data to be read. * \param [out] data The vector the read data is stored to. The Storage order is zyx. (Meaning - * your innermost loop should iterate over x) + * your innermost loop should iterate over x) * * \pre isOpen() == true * @@ -279,7 +279,7 @@ void VoxelFileReader<T>::read( const CellInterval & cellInterval, std::vector<T> * * \param cellInterval The axis-aligned bounding box of the block of data to be written. * \param data The vector holding the data to bw written to the geometry file. The Storage - * order is zyx. (Meaning your innermost loop should iterate over x) + * order is zyx. (Meaning your innermost loop should iterate over x) * * \pre isOpen() == true * \pre !cellInterval.empty() diff --git a/src/gui/BlockSliceView/DisplayAdaptor.h b/src/gui/BlockSliceView/DisplayAdaptor.h index c2723fa79..0f5d0592e 100644 --- a/src/gui/BlockSliceView/DisplayAdaptor.h +++ b/src/gui/BlockSliceView/DisplayAdaptor.h @@ -80,7 +80,7 @@ namespace gui { * Draws data structure represented by this Adaptor to a grid of cells * Block has to be set first! * - * @param [inout] grid Grid of cells. Use functions of CellView to draw + * @param [in,out] grid Grid of cells. Use functions of CellView to draw * The Grid has dimension of innerSize + ghostLayers * @param [in] nrOfGhostLayers the number of ghost layers in each direction. This value may be bigger * than the returned value of configure() since other fields might have more ghost layers. @@ -92,8 +92,6 @@ namespace gui { /** * Optionally adds a QTreeWidgetItem to a tree, containing configuration options - * - * @param parentItem the item where own items can be added */ virtual void addConfigurationItem( QTreeWidgetItem * ) {} diff --git a/src/gui/CMakeDefs.in.h b/src/gui/CMakeDefs.in.h index 79f7db72a..6d603fbe7 100644 --- a/src/gui/CMakeDefs.in.h +++ b/src/gui/CMakeDefs.in.h @@ -1,6 +1,6 @@ //====================================================================================================================== /*! - * \file CMakeDefs.h + * \file CMakeDefs.in.h * \brief Definitions for blockforest module configured by cmake */ //====================================================================================================================== diff --git a/src/lbm/PerformanceLogger.h b/src/lbm/PerformanceLogger.h index 7e7f183b7..337cf6832 100644 --- a/src/lbm/PerformanceLogger.h +++ b/src/lbm/PerformanceLogger.h @@ -44,7 +44,7 @@ namespace lbm { /*! * \brief Class for using the PerformanceEvaluation in a timeloop * -* Providing a measurement interval, this class will regularly (every <interval> time steps) measure and report the +* Providing a measurement interval, this class will regularly (every \a interval time steps) measure and report the * LBM performance. At the end of the simulation logOverallResults() may be called to output minimum, maximum and * average performance during the simulation run. */ diff --git a/src/lbm/boundary/factories/DefaultBoundaryHandlingCollection.h b/src/lbm/boundary/factories/DefaultBoundaryHandlingCollection.h index 49e77691a..cdb4edb2d 100644 --- a/src/lbm/boundary/factories/DefaultBoundaryHandlingCollection.h +++ b/src/lbm/boundary/factories/DefaultBoundaryHandlingCollection.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file DefaultBoundaryHandlingCollectionFactory.h +//! \file DefaultBoundaryHandlingCollection.h //! \ingroup lbm //! \author Matthias Markl <matthias.markl@fau.de> // diff --git a/src/lbm/boundary/factories/DefaultDiffusionBoundaryHandling.h b/src/lbm/boundary/factories/DefaultDiffusionBoundaryHandling.h index 99754f88f..89fb33500 100644 --- a/src/lbm/boundary/factories/DefaultDiffusionBoundaryHandling.h +++ b/src/lbm/boundary/factories/DefaultDiffusionBoundaryHandling.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file DefaultDiffusionBoundaryHandlingFactory.h +//! \file DefaultDiffusionBoundaryHandling.h //! \ingroup lbm //! \author Matthias Markl <matthias.markl@fau.de> // diff --git a/src/lbm/evaluations/Permeability.h b/src/lbm/evaluations/Permeability.h index 94e146f24..789969a46 100644 --- a/src/lbm/evaluations/Permeability.h +++ b/src/lbm/evaluations/Permeability.h @@ -53,11 +53,12 @@ public: Permeability( real_t viscosity, const BlockDataID & pdfFieldId, const BlockDataID & boundaryHandlingId, const FlagUID & fluid, const shared_ptr<blockforest::StructuredBlockForest> blocks ); - /*! + /*! * \brief Initializes the permeability evaluation with the parameters given in the config file. * * Configuration block: * + * \code{.unparsed} * <some_name> * { * sampleVolume [<0, 0, 0> , <100, 100, 100>]; [optional, default = domain] @@ -65,6 +66,7 @@ public: * calcFrequency 100; [required, unsigned int] * convCrit 1E-20; [optional, default = 1E-20] * } + * \endcode * * * \param config The config block handle containing the parameters. diff --git a/src/lbm/geometry/IntersectionRatio.h b/src/lbm/geometry/IntersectionRatio.h index 7ff17e71f..e877c385b 100644 --- a/src/lbm/geometry/IntersectionRatio.h +++ b/src/lbm/geometry/IntersectionRatio.h @@ -53,9 +53,9 @@ real_t intersectionRatioSphere( const geometry::Sphere & sphere, * * Let P_i be the intersection point * +* \param body surface * \param fluidPoint (P_f), start point of ray * \param direction (d) of ray (length of d is the length of the ray segment) -* \param policy defines behavior in erroneous cases * \param epsilon abortion criterion for iterative methods. Epsilon relates to the distance of P_i to the surface * \return Intersection ratio: | P_i - P_f | / | d | */ diff --git a/src/lbm/geometry/initializer/PoiseuilleInitializer.h b/src/lbm/geometry/initializer/PoiseuilleInitializer.h index fa6677a44..a44cfcd2b 100644 --- a/src/lbm/geometry/initializer/PoiseuilleInitializer.h +++ b/src/lbm/geometry/initializer/PoiseuilleInitializer.h @@ -36,6 +36,7 @@ namespace initializer { * \ingroup geometry * * Configuration file syntax: + * \code{.unparsed} * <blockName> * { * scenario rect2D|pipe; @@ -49,6 +50,7 @@ namespace initializer { * // the remaining third axis has to be periodic. By default chosen as a non-periodic axis * // that is not the flowAxis * } + * \endcode * * scenario: * - rect2D: rectangular channel where boundary in direction of periodicAxis are set periodic diff --git a/src/lbm/lattice_model/ForceModel.h b/src/lbm/lattice_model/ForceModel.h index 365b64db1..c733281ac 100644 --- a/src/lbm/lattice_model/ForceModel.h +++ b/src/lbm/lattice_model/ForceModel.h @@ -49,44 +49,44 @@ namespace force_model { * * Every force model must implement the following concept: * -* 1. Every force model must have a "tag". See force_model::None_tag and class force_model::None. If you write your +* 1. Every force model must have a "tag". See force_model::None_tag and class force_model::None. If you write your * own force model and none of the existing tags fit, just define your own empty struct and use it as tag. -* 2. Every force model must define a type "DirectionIndependentTerms_T" which must be returned by function +* 2. Every force model must define a type "DirectionIndependentTerms_T" which must be returned by function * "directionIndependentTerms" (see 9) and which is passed to function "forceTerm" (see 10) during the collision * step. [If your force model does not have or does not need to calculate any common, direction-independent terms, * you can use the empty struct force_model::NoDirectionIndependentTerms - see class force_model::None as an example] -* 3. static const bool shiftMacVel: specifies whether or not during the evaluation of the macroscopic velocity there +* 3. static const bool shiftMacVel: specifies whether or not during the evaluation of the macroscopic velocity there * is a shift by F/2 -* 4. static const bool shiftEquVel: specifies whether or not during the evaluation of the equilibrium velocity there +* 4. static const bool shiftEquVel: specifies whether or not during the evaluation of the equilibrium velocity there * is a shift by F/2 -* 5. static const bool constant: true, if the body force is constant for all cells throughout the entire simulation +* 5. static const bool constant: true, if the body force is constant for all cells throughout the entire simulation * (false otherwise) -* 6. void configure( IBlock & block, StructuredBlockStorage & sbs ): this function is called when a force model +* 6. void configure( IBlock & block, StructuredBlockStorage & sbs ): this function is called when a force model * instance is assigned to a block - can be used to * scale stored values to a different grid level -* 7. const Vector3<real_t> force() const: must return the body force (this function must only exist if constant == true) -* 8. const Vector3<real_t> force( const cell_idx_t x, const cell_idx_t y, const cell_idx_t z ) const: +* 7. const Vector3<real_t> force() const: must return the body force (this function must only exist if constant == true) +* 8. const Vector3<real_t> force( const cell_idx_t x, const cell_idx_t y, const cell_idx_t z ) const: * -> must return the force for block local cell (x,y,z) - this function must also exist for constant forces! -* 9. template< typename LatticeModel_T > +* 9. "template< typename LatticeModel_T > * DirectionIndependentTerms_T directionIndependentTerms( const cell_idx_t x, const cell_idx_t y, const cell_idx_t z, * const Vector3<real_t> & velocity, const real_t rho, -* const real_t omega ) const: +* const real_t omega ) const": * -> can be used to pre-calculate common, direction-independent terms that are needed for every lattice direction * of cell (x,y,z) * Parameters: (x,y,z) = the cell that is currently processed, velocity/rho = the velocity and density of the * equilibrium distribution, omega = relaxation parameter that corresponds to the lattice viscosity -* 10. template< typename LatticeModel_T > +* 10. "template< typename LatticeModel_T > * real_t forceTerm( const cell_idx_t x, const cell_idx_t y, const cell_idx_t z, * const Vector3<real_t> & velocity, const real_t rho, * const DirectionIndependentTerms_T & commonTerms, -* const real_t w, const real_t cx, const real_t cy, const real_t cz, const real_t omega ) const: +* const real_t w, const real_t cx, const real_t cy, const real_t cz, const real_t omega ) const": * -> must evaluate the force term of the LBM collision step - called from the LB compute kernel for every lattice * direction of cell (x,y,z) * Parameters: (x,y,z) = the cell that is currently processed, velocity/rho = the velocity and density of the * equilibrium distribution, commonTerms = direction-independent terms calculated by function * "directionIndependentTerms" (see 9), w = lattice model weighting factor, (cx,cy,cz) = lattice * direction, omega = relaxation parameter that corresponds to the lattice viscosity -* 11. bool setConstantBodyForceIfPossible( const Vector3<real_t> & force, const uint_t level = uint_t(0) ): +* 11. "bool setConstantBodyForceIfPossible( const Vector3<real_t> & force, const uint_t level = uint_t(0) )": * -> Must return true if a constant force can be set. In that case, the force passed in must be set. * 'level' is the grid level 'force' corresponds to. * diff --git a/src/lbm/vtk/QCriterionCellFilter.h b/src/lbm/vtk/QCriterionCellFilter.h index 5310bc172..26b45464c 100644 --- a/src/lbm/vtk/QCriterionCellFilter.h +++ b/src/lbm/vtk/QCriterionCellFilter.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file QValueCellFilter.h +//! \file QCriterionCellFilter.h //! \ingroup field //! \author Lukas Werner <lks.werner@fau.de> // diff --git a/src/lbm/vtk/VelocityCellFilter.h b/src/lbm/vtk/VelocityCellFilter.h index 0e290db21..50a576010 100644 --- a/src/lbm/vtk/VelocityCellFilter.h +++ b/src/lbm/vtk/VelocityCellFilter.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file VectorFieldCellFilter.h +//! \file VelocityCellFilter.h //! \ingroup field //! \author Lukas Werner <lks.werner@fau.de> // diff --git a/src/lbm_mesapd_coupling/utility/virtualmass/InitializeVirtualMassKernel.h b/src/lbm_mesapd_coupling/utility/virtualmass/InitializeVirtualMassKernel.h index f03cf4274..461dcafb0 100644 --- a/src/lbm_mesapd_coupling/utility/virtualmass/InitializeVirtualMassKernel.h +++ b/src/lbm_mesapd_coupling/utility/virtualmass/InitializeVirtualMassKernel.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file VirtualMass.h +//! \file InitializeVirtualMassKernel.h //! \author Lukas Werner <lks.werner@fau.de> // //====================================================================================================================== diff --git a/src/lbm_mesapd_coupling/utility/virtualmass/ParticleAccessorWithShapeVirtualMassWrapper.h b/src/lbm_mesapd_coupling/utility/virtualmass/ParticleAccessorWithShapeVirtualMassWrapper.h index 744a614fb..d162b5a55 100644 --- a/src/lbm_mesapd_coupling/utility/virtualmass/ParticleAccessorWithShapeVirtualMassWrapper.h +++ b/src/lbm_mesapd_coupling/utility/virtualmass/ParticleAccessorWithShapeVirtualMassWrapper.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file ParticleAccessorWithShapeAndVirtualMassWrapper.h +//! \file ParticleAccessorWithShapeVirtualMassWrapper.h //! \author Lukas Werner <lks.werner@fau.de> // //====================================================================================================================== diff --git a/src/mesa_pd/collision_detection/EPA.h b/src/mesa_pd/collision_detection/EPA.h index a83cc1f5b..b61b53e36 100644 --- a/src/mesa_pd/collision_detection/EPA.h +++ b/src/mesa_pd/collision_detection/EPA.h @@ -393,8 +393,9 @@ inline bool EPA::EPA_Triangle::isClosestInternal() const //************************************************************************************************* /*! \brief Calculates a support point of a body extended by threshold. - * Adds this support and the base points at bodies a and b to the vector. - * \param geom The body. + * Adds this support and the base points at bodies A and B to the vector. + * \param geom1 The body A. + * \param geom2 The body B. * \param dir The support point direction. * \param margin Extension of the Body. */ @@ -425,8 +426,9 @@ inline void EPA::pushSupportMargin(const Support &geom1, //************************************************************************************************* /*! \brief Calculates a support point of a body extended by threshold. - * Replaces the old value in the vectors at "IndexToReplace" with this support and the base points at bodies a and b . - * \param geom The body. + * Replaces the old value in the vectors at "IndexToReplace" with this support and the base points at bodies A and B. + * \param geom1 The body A. + * \param geom2 The body B. * \param dir The support point direction. * \param margin Extension of the Body. */ diff --git a/src/mesa_pd/collision_detection/GJK.cpp b/src/mesa_pd/collision_detection/GJK.cpp index 757c065b1..d608841ea 100644 --- a/src/mesa_pd/collision_detection/GJK.cpp +++ b/src/mesa_pd/collision_detection/GJK.cpp @@ -42,10 +42,11 @@ GJK::GJK() } /** - * \brief Calculate a support point of a particle extended by threshold. - * \param geom support functions for particle 1 and 2. + * \brief Calculate a support point of a particle extended by a threshold. + * \param geom1 The body A. + * \param geom2 The body B. * \param dir The support point direction. - * \param threshold Extension of the particle. + * \param margin The margin by which the objects will be enlarged. */ Vec3 GJK::putSupport(const Support &geom1, const Support &geom2, diff --git a/src/mesa_pd/kernel/InitParticlesForHCSITS.h b/src/mesa_pd/kernel/InitParticlesForHCSITS.h index 2022a0b80..a4b62e657 100644 --- a/src/mesa_pd/kernel/InitParticlesForHCSITS.h +++ b/src/mesa_pd/kernel/InitParticlesForHCSITS.h @@ -94,7 +94,7 @@ inline void InitParticlesForHCSITS::operator()(size_t j, Accessor& ac, real_t dt * \param ac The particle accessor * \param body The body whose velocities to time integrate * \param dv On return the initial linear velocity correction. - * \param w On return the initial angular velocity correction. + * \param dw On return the initial angular velocity correction. * \param dt The time step size. * \return void * diff --git a/src/mesa_pd/kernel/IntegrateParticlesHCSITS.h b/src/mesa_pd/kernel/IntegrateParticlesHCSITS.h index 0f00fc9a0..d598e312a 100644 --- a/src/mesa_pd/kernel/IntegrateParticlesHCSITS.h +++ b/src/mesa_pd/kernel/IntegrateParticlesHCSITS.h @@ -102,6 +102,7 @@ inline void IntegrateParticlesHCSITS::operator()(size_t j, PAccessor& ac, real_t //************************************************************************************************* /*!\brief Time integration of the position and orientation of a given body. * + * \param ac The particle accessor * \param body The body whose position and orientation to time integrate * \param v The linear velocity to use for time integration of the position. * \param w The angular velocity to use for time integration of the orientation. diff --git a/src/mesh/blockforest/BlockExclusion.h b/src/mesh/blockforest/BlockExclusion.h index 497424b89..05c397739 100644 --- a/src/mesh/blockforest/BlockExclusion.h +++ b/src/mesh/blockforest/BlockExclusion.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file PrepareDistanceComputations.h +//! \file BlockExclusion.h //! \ingroup mesh //! \author Christian Godenschwager <christian.godenschwager@fau.de> // diff --git a/src/mesh/blockforest/BlockForestInitialization.h b/src/mesh/blockforest/BlockForestInitialization.h index 12e9a2e23..d196f4fba 100644 --- a/src/mesh/blockforest/BlockForestInitialization.h +++ b/src/mesh/blockforest/BlockForestInitialization.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Initialization.h +//! \file BlockForestInitialization.h //! \ingroup mesh //! \author Christian Godenschwager <christian.godenschwager@fau.de> // diff --git a/src/mesh/blockforest/BlockWorkloadMemory.h b/src/mesh/blockforest/BlockWorkloadMemory.h index f2148ab39..3e623b79e 100644 --- a/src/mesh/blockforest/BlockWorkloadMemory.h +++ b/src/mesh/blockforest/BlockWorkloadMemory.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BlockWOrkloadMemory.h +//! \file BlockWorkloadMemory.h //! \ingroup mesh //! \author Christian Godenschwager <christian.godenschwager@fau.de> // diff --git a/src/mesh/pe/communication/ConvexPolyhedron.cpp b/src/mesh/pe/communication/ConvexPolyhedron.cpp index e7b81879b..6789d37e7 100644 --- a/src/mesh/pe/communication/ConvexPolyhedron.cpp +++ b/src/mesh/pe/communication/ConvexPolyhedron.cpp @@ -31,13 +31,6 @@ namespace walberla { namespace mesh { namespace pe { -//************************************************************************************************* -/*!\brief Marshalling a polyhedron primitive. - * - * \param buffer The buffer to be filled. - * \param obj The object to be marshalled. - * \return void - */ void marshal( mpi::SendBuffer& buffer, const ConvexPolyhedron& obj ) { walberla::pe::communication::marshal( buffer, static_cast<const GeomPrimitive&>( obj ) ); @@ -76,14 +69,6 @@ void marshal( mpi::SendBuffer& buffer, const ConvexPolyhedron& obj ) { //************************************************************************************************* -//************************************************************************************************* -/*!\brief Unmarshalling a polyhedron primitive. - * - * \param buffer The buffer from where to read. - * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. - * \return void - */ void unmarshal( mpi::RecvBuffer& buffer, ConvexPolyhedronParameters& objparam ) { walberla::pe::communication::unmarshal( buffer, static_cast<GeomPrimitiveParameters&>( objparam ) ); diff --git a/src/mesh/pe/communication/ConvexPolyhedron.h b/src/mesh/pe/communication/ConvexPolyhedron.h index 1527530b4..888e3c16f 100644 --- a/src/mesh/pe/communication/ConvexPolyhedron.h +++ b/src/mesh/pe/communication/ConvexPolyhedron.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Polyhedron.h +//! \file ConvexPolyhedron.h //! \author Christian Godenschwager <christian.godenschwager@fau.de> //! \brief Marshalling of objects for data transmission or storage. // @@ -55,7 +55,6 @@ void marshal( mpi::SendBuffer& buffer, const ConvexPolyhedron& obj ); * * \param buffer The buffer from where to read. * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. * \return void */ void unmarshal( mpi::RecvBuffer& buffer, ConvexPolyhedronParameters& objparam ); diff --git a/src/mesh/pe/rigid_body/ConvexPolyhedron.cpp b/src/mesh/pe/rigid_body/ConvexPolyhedron.cpp index 933a6d28f..f8c1efee0 100644 --- a/src/mesh/pe/rigid_body/ConvexPolyhedron.cpp +++ b/src/mesh/pe/rigid_body/ConvexPolyhedron.cpp @@ -54,9 +54,7 @@ namespace pe { * \param sid Unique system-specific ID for the ConvexPolyhedron. * \param uid User-specific ID for the ConvexPolyhedron. * \param gpos Global geometric center of the ConvexPolyhedron. -* \param rpos The relative position within the body frame of a superordinate body. * \param q The orientation of the ConvexPolyhedron's body frame in the global world frame. -* \param radius The radius of the ConvexPolyhedron \f$ (0..\infty) \f$. * \param material The material of the ConvexPolyhedron. * \param global specifies if the ConvexPolyhedron should be created in the global storage * \param communicating specifies if the ConvexPolyhedron should take part in synchronization (syncNextNeighbour, syncShadowOwner) diff --git a/src/mesh_common/DistanceComputations.h b/src/mesh_common/DistanceComputations.h index 9155aa1d1..ec244cf0f 100644 --- a/src/mesh_common/DistanceComputations.h +++ b/src/mesh_common/DistanceComputations.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file PrepareDistanceComputations.h +//! \file DistanceComputations.h //! \ingroup mesh //! \author Christian Godenschwager <christian.godenschwager@fau.de> // diff --git a/src/pde/iterations/VCycles.impl.h b/src/pde/iterations/VCycles.impl.h index fea9a4031..8cf132a14 100644 --- a/src/pde/iterations/VCycles.impl.h +++ b/src/pde/iterations/VCycles.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file VCycles.h.impl +//! \file VCycles.impl.h //! \ingroup pde //! \author Dominik Bartuschat <dominik.bartuschat@fau.de> //! \author Michael Kuron <mkuron@icp.uni-stuttgart.de> diff --git a/src/pe/Types.h b/src/pe/Types.h index 645f16780..463aab788 100644 --- a/src/pe/Types.h +++ b/src/pe/Types.h @@ -144,7 +144,7 @@ using Materials = std::vector<Material>; //!< Vector for materials. /*!\brief Unique material ID. * * Every registered material has a unique MaterialID that can be used wherever the material is - * required. The \b pe engine provides a couple of predefined materials (see the \ref materials + * required. The \b pe engine provides a couple of predefined materials (see the \ref Materials * module). However, it is possible to define a custom material via the createMaterial() function: \code diff --git a/src/pe/ccd/HashGrids.cpp b/src/pe/ccd/HashGrids.cpp index 5c2f691ed..6855622a4 100644 --- a/src/pe/ccd/HashGrids.cpp +++ b/src/pe/ccd/HashGrids.cpp @@ -326,7 +326,7 @@ size_t HashGrids::HashGrid::hash( BodyID body ) const * * \param x X value of the point. * \param y Y value of the point. - * \param y Z value of the point. + * \param z Z value of the point. * \return The hash value (=cell association) of the point. * * The hash calculation uses modulo operations in order to spatially map entire blocks of connected @@ -569,12 +569,12 @@ void HashGrids::HashGrid::enlarge() //================================================================================================= //************************************************************************************************* -/*!\brief Constructor for the HashGrids class. - * - * \param bodystorage Reference to the general body storage. - * - * Note that all (local, global and remote) must be contained in the body storage. - */ +//\brief Constructor for the HashGrids class. +//* +//* \param bodystorage Reference to the general body storage. +//* +//* Note that all (local, global and remote) must be contained in the body storage. +// //HashGrids::HashGrids( BodyStorage& bodystorage ) // : bodystorage_( bodystorage ) // , bodystorageShadowCopies_( bodystorage ) diff --git a/src/pe/ccd/HashGrids.h b/src/pe/ccd/HashGrids.h index 395201c09..6528f1910 100644 --- a/src/pe/ccd/HashGrids.h +++ b/src/pe/ccd/HashGrids.h @@ -502,7 +502,6 @@ void HashGrids::HashGrid::processBodies( BodyID* bodies, size_t bodyCount, Conta /*!\brief Computes closest ray-body intersection of cell with center at point x,y,z and neighboring ones. * * \param blockCell index of cell within block grid. - * \param blockAABB AABB of the block this grid corresponds to. * \param ray Ray being casted trough grid. * \param t_closest Distance of closest object from ray origin. Will be updated if closer body found. * \param n_closest Normal of intersection point. @@ -604,8 +603,8 @@ BodyID HashGrids::HashGrid::getBodyIntersectionForBlockCell(const Vector3<int32_ * * \param ray Ray getting shot through this grid. * \param blockAABB AABB of the block this grid corresponds to. - * \param t Reference for the distance. - * \param n Reference for the intersection normal. + * \param t_closest Reference for the distance. + * \param n_closest Reference for the intersection normal. * \return BodyID of closest body, NULL if none found. * * This function calculates ray-cell intersections and the closest body in those cells. Also, neighboring diff --git a/src/pe/collision/EPA.h b/src/pe/collision/EPA.h index 6c5d76265..e78a67710 100644 --- a/src/pe/collision/EPA.h +++ b/src/pe/collision/EPA.h @@ -402,7 +402,7 @@ inline const Vec3& EPA::EPA_Triangle::getNormal() const */ inline Vec3 EPA::EPA_Triangle::getClosestPoint(const std::vector<Vec3>& points) const { - return bar_[0] * points[indices_[0]] + return bar_[0] * points[indices_[0]] + bar_[1] * points[indices_[1]] + bar_[2] * points[indices_[2]]; @@ -469,8 +469,9 @@ inline bool EPA::EPA_TriangleComp::operator()( const EPA_Triangle *tria1, //************************************************************************************************* /*! \brief Calculates a support point of a body extended by threshold. - * Adds this support and the base points at bodies a and b to the vector. - * \param geom The body. + * Adds this support and the base points at bodies A and B to the vector. + * \param geom1 The body A. + * \param geom2 The body B. * \param dir The support point direction. * \param margin Extension of the Body. */ @@ -496,8 +497,9 @@ inline void EPA::pushSupportMargin(const GeomPrimitive &geom1, const GeomPrimiti //************************************************************************************************* /*! \brief Calculates a support point of a body extended by threshold. - * Replaces the old value in the vectors at "IndexToReplace" with this support and the base points at bodies a and b . - * \param geom The body. + * Replaces the old value in the vectors at "IndexToReplace" with this support and the base points at bodies A and B. + * \param geom1 The body A. + * \param geom2 The body B. * \param dir The support point direction. * \param margin Extension of the Body. */ diff --git a/src/pe/collision/GJK.h b/src/pe/collision/GJK.h index 15680d93f..c5ef0417a 100644 --- a/src/pe/collision/GJK.h +++ b/src/pe/collision/GJK.h @@ -185,10 +185,11 @@ inline bool GJK::zeroLengthVector(const Vec3& vec) const //************************************************************************************************* -/*!\brief Calculate a support point of a body extended by threshold. - * \param geom The body. +/*!\brief Calculate a support point of a body extended by a threshold. + * \param geom1 The body A. + * \param geom2 The body B. * \param dir The support point direction. - * \param threshold Extension of the Body. + * \param margin Extension of the Body. */ inline const Vec3 GJK::putSupport(const GeomPrimitive &geom1, const GeomPrimitive &geom2, const Vec3& dir, const real_t margin, std::vector<Vec3> &simplex, std::vector<Vec3> &supportA, std::vector<Vec3> &supportB, size_t index){ diff --git a/src/pe/communication/DynamicMarshalling.h b/src/pe/communication/DynamicMarshalling.h index 8e996c3c6..941d6344c 100644 --- a/src/pe/communication/DynamicMarshalling.h +++ b/src/pe/communication/DynamicMarshalling.h @@ -61,7 +61,7 @@ public: /*!\brief Marshalling rigid body parameters dynamically. * * \param buffer The buffer to be filled. - * \param obj The object to be marshalled dynamically. + * \param b The object to be marshalled dynamically. * \return void * * The rigid body is casted dynamically to its original type and then marshalled. For recognition @@ -97,7 +97,6 @@ public: /*!\brief Marshalling rigid body parameters dynamically. * * \param buffer The buffer to be filled. - * \param obj The object to be marshalled dynamically. * \return void * * The rigid body is casted dynamically to its original type and then marshalled. For recognition diff --git a/src/pe/communication/Marshalling.cpp b/src/pe/communication/Marshalling.cpp index 9a8e930f6..4ec35b4ff 100644 --- a/src/pe/communication/Marshalling.cpp +++ b/src/pe/communication/Marshalling.cpp @@ -27,36 +27,17 @@ namespace pe { namespace communication { //************************************************************************************************* -/*!\brief Marshalling rigid body parameters. - * - * \param buffer The buffer to be filled. - * \param obj The object to be marshalled. - * \return void - */ void marshal( mpi::SendBuffer& buffer, const MPIRigidBodyTrait& obj ) { buffer << obj.getOwner(); } //************************************************************************************************* //************************************************************************************************* -/*!\brief Unmarshalling rigid body parameters. - * - * \param buffer The buffer from where to read. - * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Subordinate bodies in unions do not encode velocities but encode relative positions. - * \return void - */ void unmarshal( mpi::RecvBuffer& buffer, MPIRigidBodyTraitParameter& objparam ) { buffer >> objparam.owner_; } //************************************************************************************************* -/*!\brief Marshalling rigid body parameters. - * - * \param buffer The buffer to be filled. - * \param obj The object to be marshalled. - * \return void - */ void marshal( mpi::SendBuffer& buffer, const RigidBody& obj ) { marshal( buffer, obj.MPITrait ); @@ -76,13 +57,6 @@ void marshal( mpi::SendBuffer& buffer, const RigidBody& obj ) { //************************************************************************************************* //************************************************************************************************* -/*!\brief Unmarshalling rigid body parameters. - * - * \param buffer The buffer from where to read. - * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Subordinate bodies in unions do not encode velocities but encode relative positions. - * \return void - */ void unmarshal( mpi::RecvBuffer& buffer, RigidBodyParameters& objparam ) { unmarshal( buffer, objparam.mpiTrait_ ); @@ -109,12 +83,6 @@ void unmarshal( mpi::RecvBuffer& buffer, RigidBodyParameters& objparam ) { //************************************************************************************************* //************************************************************************************************* -/*!\brief Marshalling parameters of a geometric primitive. - * - * \param buffer The buffer to be filled. - * \param obj The object to be marshalled. - * \return void - */ void marshal( mpi::SendBuffer& buffer, const GeomPrimitive& obj ) { marshal( buffer, static_cast<const RigidBody&>( obj ) ); buffer << obj.getMaterial(); @@ -123,13 +91,6 @@ void marshal( mpi::SendBuffer& buffer, const GeomPrimitive& obj ) { //************************************************************************************************* -/*!\brief Unmarshalling parameters of a geometric primitive. - * - * \param buffer The buffer to be filled. - * \param obj The object to be marshalled. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. - * \return void - */ void unmarshal( mpi::RecvBuffer& buffer, GeomPrimitiveParameters& objparam ) { unmarshal( buffer, static_cast<RigidBodyParameters&>( objparam ) ); buffer >> objparam.material_; diff --git a/src/pe/communication/Marshalling.h b/src/pe/communication/Marshalling.h index 413636274..759e7640c 100644 --- a/src/pe/communication/Marshalling.h +++ b/src/pe/communication/Marshalling.h @@ -59,7 +59,6 @@ void marshal( mpi::SendBuffer& buffer, const MPIRigidBodyTrait& obj ); * * \param buffer The buffer from where to read. * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Subordinate bodies in unions do not encode velocities but encode relative positions. * \return void */ void unmarshal( mpi::RecvBuffer& buffer, MPIRigidBodyTraitParameter& objparam ); @@ -95,7 +94,6 @@ void marshal( mpi::SendBuffer& buffer, const RigidBody& obj ); * * \param buffer The buffer from where to read. * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Subordinate bodies in unions do not encode velocities but encode relative positions. * \return void */ void unmarshal( mpi::RecvBuffer& buffer, RigidBodyParameters& objparam ); @@ -126,8 +124,7 @@ void marshal( mpi::SendBuffer& buffer, const GeomPrimitive& obj ); /*!\brief Unmarshalling parameters of a geometric primitive. * * \param buffer The buffer to be filled. - * \param obj The object to be marshalled. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. + * \param objparam The object to be marshalled. * \return void */ void unmarshal( mpi::RecvBuffer& buffer, GeomPrimitiveParameters& objparam ); diff --git a/src/pe/communication/rigidbody/Box.cpp b/src/pe/communication/rigidbody/Box.cpp index 1b5bb4aac..f44f8aa87 100644 --- a/src/pe/communication/rigidbody/Box.cpp +++ b/src/pe/communication/rigidbody/Box.cpp @@ -27,12 +27,6 @@ namespace pe { namespace communication { //************************************************************************************************* -/*!\brief Marshalling a sphere primitive. - * - * \param buffer The buffer to be filled. - * \param obj The object to be marshalled. - * \return void - */ void marshal( mpi::SendBuffer& buffer, const Box& obj ) { marshal( buffer, static_cast<const GeomPrimitive&>( obj ) ); buffer << obj.getLengths(); @@ -41,13 +35,6 @@ void marshal( mpi::SendBuffer& buffer, const Box& obj ) { //************************************************************************************************* -/*!\brief Unmarshalling a sphere primitive. - * - * \param buffer The buffer from where to read. - * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. - * \return void - */ void unmarshal( mpi::RecvBuffer& buffer, BoxParameters& objparam ) { unmarshal( buffer, static_cast<GeomPrimitiveParameters&>( objparam ) ); buffer >> objparam.lengths_; diff --git a/src/pe/communication/rigidbody/Box.h b/src/pe/communication/rigidbody/Box.h index 78d698f48..775da39cf 100644 --- a/src/pe/communication/rigidbody/Box.h +++ b/src/pe/communication/rigidbody/Box.h @@ -54,7 +54,6 @@ void marshal( mpi::SendBuffer& buffer, const Box& obj ); * * \param buffer The buffer from where to read. * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. * \return void */ void unmarshal( mpi::RecvBuffer& buffer, BoxParameters& objparam ); diff --git a/src/pe/communication/rigidbody/Capsule.cpp b/src/pe/communication/rigidbody/Capsule.cpp index 849945919..58b198955 100644 --- a/src/pe/communication/rigidbody/Capsule.cpp +++ b/src/pe/communication/rigidbody/Capsule.cpp @@ -27,12 +27,6 @@ namespace pe { namespace communication { //************************************************************************************************* -/*!\brief Marshalling a capsule primitive. - * - * \param buffer The buffer to be filled. - * \param obj The object to be marshalled. - * \return void - */ void marshal( mpi::SendBuffer& buffer, const Capsule& obj ) { marshal( buffer, static_cast<const GeomPrimitive&>( obj ) ); @@ -43,13 +37,6 @@ void marshal( mpi::SendBuffer& buffer, const Capsule& obj ) //************************************************************************************************* -/*!\brief Unmarshalling a capsule primitive. - * - * \param buffer The buffer from where to read. - * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. - * \return void - */ void unmarshal( mpi::RecvBuffer& buffer, CapsuleParameters& objparam ) { unmarshal( buffer, static_cast<GeomPrimitiveParameters&>( objparam ) ); diff --git a/src/pe/communication/rigidbody/Capsule.h b/src/pe/communication/rigidbody/Capsule.h index e319d579a..0ab8a4cf7 100644 --- a/src/pe/communication/rigidbody/Capsule.h +++ b/src/pe/communication/rigidbody/Capsule.h @@ -54,7 +54,6 @@ void marshal( mpi::SendBuffer& buffer, const Capsule& obj ); * * \param buffer The buffer from where to read. * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. * \return void */ void unmarshal( mpi::RecvBuffer& buffer, CapsuleParameters& objparam ); diff --git a/src/pe/communication/rigidbody/Ellipsoid.cpp b/src/pe/communication/rigidbody/Ellipsoid.cpp index d7e7199a4..db9ef8e4c 100644 --- a/src/pe/communication/rigidbody/Ellipsoid.cpp +++ b/src/pe/communication/rigidbody/Ellipsoid.cpp @@ -27,12 +27,6 @@ namespace pe { namespace communication { //************************************************************************************************* -/*!\brief Marshalling a Ellipsoid primitive. - * - * \param buffer The buffer to be filled. - * \param obj The object to be marshalled. - * \return void - */ void marshal( mpi::SendBuffer& buffer, const Ellipsoid& obj ) { marshal( buffer, static_cast<const GeomPrimitive&>( obj ) ); buffer << obj.getSemiAxes(); @@ -41,13 +35,6 @@ void marshal( mpi::SendBuffer& buffer, const Ellipsoid& obj ) { //************************************************************************************************* -/*!\brief Unmarshalling a Ellipsoid primitive. - * - * \param buffer The buffer from where to read. - * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. - * \return void - */ void unmarshal( mpi::RecvBuffer& buffer, EllipsoidParameters& objparam ) { unmarshal( buffer, static_cast<GeomPrimitiveParameters&>( objparam ) ); buffer >> objparam.semiAxes_; diff --git a/src/pe/communication/rigidbody/Ellipsoid.h b/src/pe/communication/rigidbody/Ellipsoid.h index de8787b45..bd6e03d82 100644 --- a/src/pe/communication/rigidbody/Ellipsoid.h +++ b/src/pe/communication/rigidbody/Ellipsoid.h @@ -54,7 +54,6 @@ void marshal( mpi::SendBuffer& buffer, const Ellipsoid& obj ); * * \param buffer The buffer from where to read. * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. * \return void */ void unmarshal( mpi::RecvBuffer& buffer, EllipsoidParameters& objparam ); diff --git a/src/pe/communication/rigidbody/Sphere.cpp b/src/pe/communication/rigidbody/Sphere.cpp index dedd8367f..cb0dd3c07 100644 --- a/src/pe/communication/rigidbody/Sphere.cpp +++ b/src/pe/communication/rigidbody/Sphere.cpp @@ -27,12 +27,6 @@ namespace pe { namespace communication { //************************************************************************************************* -/*!\brief Marshalling a sphere primitive. - * - * \param buffer The buffer to be filled. - * \param obj The object to be marshalled. - * \return void - */ void marshal( mpi::SendBuffer& buffer, const Sphere& obj ) { marshal( buffer, static_cast<const GeomPrimitive&>( obj ) ); buffer << obj.getRadius(); @@ -41,13 +35,6 @@ void marshal( mpi::SendBuffer& buffer, const Sphere& obj ) { //************************************************************************************************* -/*!\brief Unmarshalling a sphere primitive. - * - * \param buffer The buffer from where to read. - * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. - * \return void - */ void unmarshal( mpi::RecvBuffer& buffer, SphereParameters& objparam ) { unmarshal( buffer, static_cast<GeomPrimitiveParameters&>( objparam ) ); buffer >> objparam.radius_; diff --git a/src/pe/communication/rigidbody/Sphere.h b/src/pe/communication/rigidbody/Sphere.h index 846a621e5..26816341b 100644 --- a/src/pe/communication/rigidbody/Sphere.h +++ b/src/pe/communication/rigidbody/Sphere.h @@ -54,7 +54,6 @@ void marshal( mpi::SendBuffer& buffer, const Sphere& obj ); * * \param buffer The buffer from where to read. * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. * \return void */ void unmarshal( mpi::RecvBuffer& buffer, SphereParameters& objparam ); diff --git a/src/pe/communication/rigidbody/Union.h b/src/pe/communication/rigidbody/Union.h index cb10cd0e0..130acc6e2 100644 --- a/src/pe/communication/rigidbody/Union.h +++ b/src/pe/communication/rigidbody/Union.h @@ -90,7 +90,6 @@ void marshal( mpi::SendBuffer& buffer, const Union<BodyTypes...>& obj ) * * \param buffer The buffer from where to read. * \param objparam The object to be reconstructed. - * \param hasSuperBody False if body is not part of a union. Passed on to rigid body unmarshalling. * \return void */ inline diff --git a/src/pe/cr/HCSITS.h b/src/pe/cr/HCSITS.h index 24b3d7d59..497905967 100644 --- a/src/pe/cr/HCSITS.h +++ b/src/pe/cr/HCSITS.h @@ -328,7 +328,7 @@ inline real_t HardContactSemiImplicitTimesteppingSolvers::getSpeedLimitFactor() //************************************************************************************************* /*!\brief Sets the relaxation parameter for boundary bodies. * - * \param f The overrelaxation parameter. + * \param omega The overrelaxation parameter. * \return void * * The overrelaxation parameter \a omega is only used when the relaxation model is one of diff --git a/src/pe/cr/HCSITS.impl.h b/src/pe/cr/HCSITS.impl.h index b46362df2..6d7751cb4 100644 --- a/src/pe/cr/HCSITS.impl.h +++ b/src/pe/cr/HCSITS.impl.h @@ -1759,7 +1759,7 @@ inline void HardContactSemiImplicitTimesteppingSolvers::synchronizeVelocities( ) * * \param body The body whose velocities to time integrate * \param dv On return the initial linear velocity correction. - * \param w On return the initial angular velocity correction. + * \param dw On return the initial angular velocity correction. * \param dt The time step size. * \return void * diff --git a/src/pe/fcd/AnalyticCollisionDetection.h b/src/pe/fcd/AnalyticCollisionDetection.h index 65737205c..4bc5bf646 100644 --- a/src/pe/fcd/AnalyticCollisionDetection.h +++ b/src/pe/fcd/AnalyticCollisionDetection.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Collide.h +//! \file AnalyticCollisionDetection.h //! \author Klaus Iglberger //! \author Tobias Scharpff //! \author Sebastian Eibl <sebastian.eibl@fau.de> @@ -149,9 +149,6 @@ namespace analytic { //************************************************************************************************* /*!\brief Contact generation between two colliding rigid bodies. * - * \param s1 The first colliding rigid body. - * \param s2 The second colliding rigid body. - * \param contacts Contact container for the generated contacts. * \return true if contact is detected, false otherwise * * \attention If no contact was detected the value of penetrationDepth, contactPoint, contactNormal is undefined! @@ -364,7 +361,7 @@ bool collide( BoxID b, SphereID s, Container& container ) * * \param b1 The first colliding box. * \param b2 The second colliding box. - * \param contacts Contact container for the generated contacts. + * \param container Contact container for the generated contacts. * \return void */ template <typename Container> @@ -1828,7 +1825,7 @@ bool collide( PlaneID p, BoxID b, Container& container ) * * \param c1 The first colliding capsule. * \param c2 The second colliding capsule. - * \param contacts Contact container for the generated contacts. + * \param container Contact container for the generated contacts. * \return void * * In case of two colliding capsules one or two contact points may be generated. In order to diff --git a/src/pe/raytracing/Color.h b/src/pe/raytracing/Color.h index cf5999304..c9b2ad225 100644 --- a/src/pe/raytracing/Color.h +++ b/src/pe/raytracing/Color.h @@ -48,9 +48,7 @@ public: } /*!\brief Instantiation constructor for the Color class. - * \param r Red component - * \param g Green component - * \param b Blue component + * \param vector RGB vector * Instantiation constructor for the Color class with RGB components. Each value should be between 0 and 1 (soft limits) */ Color (const Vec3& vector) : Color(vector[0], vector[1], vector[2]) { diff --git a/src/pe/raytracing/Lighting.h b/src/pe/raytracing/Lighting.h index 1d64cbc87..5957dc59b 100644 --- a/src/pe/raytracing/Lighting.h +++ b/src/pe/raytracing/Lighting.h @@ -42,10 +42,10 @@ struct Lighting { Lighting () = default; /*!\brief Instantiation constructor for the Lighting struct. - * \param pointLightOrigin Origin of the point light. - * \param diffuseColor Diffuse color (base color of the light). - * \param specularColor Specular color (color of light refractions on an objects surface). - * \param ambientColor Color of the ambient light in the scene. + * \param _pointLightOrigin Origin of the point light. + * \param _diffuseColor Diffuse color (base color of the light). + * \param _specularColor Specular color (color of light refractions on an objects surface). + * \param _ambientColor Color of the ambient light in the scene. */ Lighting (const Vec3& _pointLightOrigin, const Color& _diffuseColor, const Color& _specularColor, const Color& _ambientColor) diff --git a/src/pe/raytracing/Raytracer.cpp b/src/pe/raytracing/Raytracer.cpp index d4770039d..daff4eb3e 100644 --- a/src/pe/raytracing/Raytracer.cpp +++ b/src/pe/raytracing/Raytracer.cpp @@ -366,6 +366,7 @@ void Raytracer::syncImageUsingMPIReduce(std::vector<BodyIntersectionInfo>& inter } /*!\brief Conflate the intersectionsBuffer of each process onto the root process using MPI_Gather. + * \param intersections Intersections to conflate. * \param intersectionsBuffer Buffer containing intersections. * \param tt Optional TimingTree. * diff --git a/src/pe/raytracing/Raytracer.h b/src/pe/raytracing/Raytracer.h index f53152760..ed4c6c864 100644 --- a/src/pe/raytracing/Raytracer.h +++ b/src/pe/raytracing/Raytracer.h @@ -344,8 +344,8 @@ inline void Raytracer::setLocalImageOutputEnabled(const bool enabled) { localImageOutputEnabled_ = enabled; } -/*!\brief Enable / disable outputting images in the specified directory. - * \param enabled Set to true / false to enable / disable image output. +/*!\brief Enable outputting images in the specified directory. + * \param path Directory for image output. */ inline void Raytracer::setImageOutputDirectory(const std::string& path) { filesystem::path dir (path); @@ -376,7 +376,7 @@ inline void Raytracer::setReductionMethod(ReductionMethod reductionMethod) { } /*!\brief Set if the rendering of planes should get confined to the simulation domain. - * \param confinePlanesToOrigin True if the rendering of planes should get confined to the simulation domain. + * \param confinePlanesToDomain True if the rendering of planes should get confined to the simulation domain. */ inline void Raytracer::setConfinePlanesToDomain(bool confinePlanesToDomain) { confinePlanesToDomain_ = confinePlanesToDomain; @@ -513,6 +513,7 @@ inline void Raytracer::traceRayInHashGrids(const Ray& ray, BodyID& body_closest, /*!\brief Does one raytracing step. * * \param timestep The timestep after which the raytracing starts. + * \param tt Optional TimingTree. * * \attention Planes will not get rendered if their normal and the rays direction point in the approximately * same direction. See Raytracer::isPlaneVisible() for further information. @@ -668,7 +669,7 @@ void Raytracer::generateImage(const size_t timestep, WcTimingTree* tt) { /*!\brief Computes the color for a certain intersection. * * \param body Intersected body. - * \param Ray Ray which intersected the body. + * \param ray Ray which intersected the body. * \param t Distance from eye to intersection point. * \param n Intersection normal at the intersection point. * diff --git a/src/pe/raytracing/ShadingFunctions.h b/src/pe/raytracing/ShadingFunctions.h index 65675bb21..de5f0c43f 100644 --- a/src/pe/raytracing/ShadingFunctions.h +++ b/src/pe/raytracing/ShadingFunctions.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Shading.h +//! \file ShadingFunctions.h //! \author Lukas Werner // //====================================================================================================================== diff --git a/src/pe/raytracing/ShadingParameters.h b/src/pe/raytracing/ShadingParameters.h index c6a7eb16c..c3d443a71 100644 --- a/src/pe/raytracing/ShadingParameters.h +++ b/src/pe/raytracing/ShadingParameters.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Shading.h +//! \file ShadingParameters.h //! \author Lukas Werner // //====================================================================================================================== @@ -39,10 +39,10 @@ struct ShadingParameters { ShadingParameters () = default; /*!\brief Instantiation constructor for the Shading struct. - * \param diffuseColor Primary color of the material. - * \param ambientColor Color the material has even when its not directly lit. - * \param specularColor Color this material contributes to on its specular highlights. - * \param shininess Shininess of the material. + * \param _diffuseColor Primary color of the material. + * \param _ambientColor Color the material has even when its not directly lit. + * \param _specularColor Color this material contributes to on its specular highlights. + * \param _shininess Shininess of the material. */ ShadingParameters (const Color& _diffuseColor, const Color& _ambientColor, const Color& _specularColor, real_t _shininess) : diffuseColor(_diffuseColor), ambientColor(_ambientColor), specularColor(_specularColor), shininess(_shininess) { diff --git a/src/pe/rigidbody/Box.cpp b/src/pe/rigidbody/Box.cpp index 0705a4ca1..e7a65f7e9 100644 --- a/src/pe/rigidbody/Box.cpp +++ b/src/pe/rigidbody/Box.cpp @@ -48,12 +48,12 @@ namespace pe { * \param sid Unique system-specific ID for the box. * \param uid User-specific ID for the box. * \param gpos Global geometric center of the box. - * \param rpos The relative position within the body frame of a superordinate body. * \param q The orientation of the box's body frame in the global world frame. * \param lengths Side lengths of the box \f$ (0..\infty) \f$. * \param material The material of the box. - * \param visible Specifies if the box is visible in a visualization. - * \param fixed \a true to fix the box, \a false to unfix it. + * \param global specifies if the box should be created in the global storage + * \param communicating specifies if the box should take part in synchronization (syncNextNeighbour, syncShadowOwner) + * \param infiniteMass specifies if the box has infinite mass and will be treated as an obstacle */ Box::Box( id_t sid, id_t uid, const Vec3& gpos, const Quat& q, const Vec3& lengths, MaterialID material, diff --git a/src/pe/rigidbody/Capsule.cpp b/src/pe/rigidbody/Capsule.cpp index b544f0851..b51436114 100644 --- a/src/pe/rigidbody/Capsule.cpp +++ b/src/pe/rigidbody/Capsule.cpp @@ -48,10 +48,13 @@ namespace pe { * \param sid Unique system-specific ID for the capsule. * \param uid User-specific ID for the capsule. * \param gpos Global geometric center of the capsule. + * \param q The orientation of the capsule's body frame in the global world frame. * \param radius The radius of the cylinder part and the end caps \f$ (0..\infty) \f$. * \param length The length of the cylinder part \f$ (0..\infty) \f$. * \param material The material of the capsule. - * \param visible Specifies if the capsule is visible in a visualization. + * \param global specifies if the capsule should be created in the global storage + * \param communicating specifies if the capsule should take part in synchronization (syncNextNeighbour, syncShadowOwner) + * \param infiniteMass specifies if the capsule has infinite mass and will be treated as an obstacle * * The capsule is created lying along the x-axis. */ diff --git a/src/pe/rigidbody/CapsuleFactory.h b/src/pe/rigidbody/CapsuleFactory.h index 012522b60..19a2b89d2 100644 --- a/src/pe/rigidbody/CapsuleFactory.h +++ b/src/pe/rigidbody/CapsuleFactory.h @@ -47,7 +47,6 @@ namespace pe { * \param storageID BlockDataID of the BlockStorage block datum * \param uid The user-specific ID of the capsule. * \param gpos The global position of the center of the capsule. - * \param q The orientation of the capsule's body frame in the global world frame. * \param radius The radius of the cylinder part and the end caps \f$ (0..\infty) \f$. * \param length The length of the cylinder part of the capsule \f$ (0..\infty) \f$. * \param material The material of the capsule. diff --git a/src/pe/rigidbody/Ellipsoid.cpp b/src/pe/rigidbody/Ellipsoid.cpp index d47b400d5..59d396338 100644 --- a/src/pe/rigidbody/Ellipsoid.cpp +++ b/src/pe/rigidbody/Ellipsoid.cpp @@ -50,9 +50,8 @@ namespace pe { * \param sid Unique system-specific ID for the Ellipsoid. * \param uid User-specific ID for the Ellipsoid. * \param gpos Global geometric center of the Ellipsoid. - * \param rpos The relative position within the body frame of a superordinate body. * \param q The orientation of the Ellipsoid's body frame in the global world frame. - * \param radius The radius of the Ellipsoid \f$ (0..\infty) \f$. + * \param semiAxes The semi-axes of the Ellipsoid. * \param material The material of the Ellipsoid. * \param global specifies if the Ellipsoid should be created in the global storage * \param communicating specifies if the Ellipsoid should take part in synchronization (syncNextNeighbour, syncShadowOwner) diff --git a/src/pe/rigidbody/GeomPrimitive.cpp b/src/pe/rigidbody/GeomPrimitive.cpp index 0594e19a3..97dbcef56 100644 --- a/src/pe/rigidbody/GeomPrimitive.cpp +++ b/src/pe/rigidbody/GeomPrimitive.cpp @@ -40,7 +40,7 @@ namespace pe { //************************************************************************************************* /*!\brief Constructor for the GeomPrimitive class. * - * \param type The geometry type of the geometric primitive. + * \param typeID The geometry type of the geometric primitive. * \param sid The unique system-specific ID of the geometric primitive. * \param uid The user-specific ID of the geometric primitive. * \param material The material of the geometric primitive. diff --git a/src/pe/rigidbody/MPIRigidBodyTrait.h b/src/pe/rigidbody/MPIRigidBodyTrait.h index 5e24baa29..050181c06 100644 --- a/src/pe/rigidbody/MPIRigidBodyTrait.h +++ b/src/pe/rigidbody/MPIRigidBodyTrait.h @@ -136,7 +136,7 @@ inline MPIRigidBodyTrait::MPIRigidBodyTrait( ) //************************************************************************************************* /*!\brief Registering a new remote process the rigid body is contained in. * - * \param process The remote process to be registered with the rigid body. + * \param owner The remote process to be registered with the rigid body. * \return void * * This function registers the given remote process with the rigid body. In case the process is @@ -153,7 +153,7 @@ inline void MPIRigidBodyTrait::registerShadowOwner( const Owner& owner ) //************************************************************************************************* /*!\brief Deregistering a remote process from the rigid body. * - * \param process The remote process to be deregistered from the rigid body. + * \param owner The remote process to be deregistered from the rigid body. * \return void * * This function deregisters the given remote process from the rigid body. This call has linear @@ -171,7 +171,7 @@ inline void MPIRigidBodyTrait::deregisterShadowOwner( const Owner& owner ) //************************************************************************************************* /*!\brief Checks whether the given remote process is registered with the rigid body. * - * \param process The remote process that possibly registered with the rigid body. + * \param owner The remote process that possibly registered with the rigid body. * \return \a true if the given process is registered with the rigid body, \a false if not. * * This call has linear complexity. diff --git a/src/pe/rigidbody/Plane.cpp b/src/pe/rigidbody/Plane.cpp index 0d501c60d..bf2a7908a 100644 --- a/src/pe/rigidbody/Plane.cpp +++ b/src/pe/rigidbody/Plane.cpp @@ -189,7 +189,8 @@ void Plane::setPositionImpl( real_t px, real_t py, real_t pz ) //************************************************************************************************* /*!\brief Setting the global orientation of the plane. * - * \param q The global orientation. + * \param r The quaternion scalar part. + * \param i,j,k The quaternion vector part. * \return void * \exception std::logic_error Invalid rotation of a plane inside an exclusive section. * @@ -319,13 +320,12 @@ void Plane::rotateImpl( const Quat& dq ) //************************************************************************************************* /*!\brief Rotation of the plane around the origin of the global world frame. * - * \param axis The global rotation axis. - * \param angle The rotation angle (radian measure). + * \param dq The quaternion for the rotation. * \return void * \exception std::logic_error Invalid rotation of a plane inside an exclusive section. * * Changing the orientation/rotation of the plane. The plane is rotated around the origin of - * the global frame around the given axis \a (x,y,z) by \a angle degrees (radian measure). + * the global frame around by the quaternion \a dq. * Therefore the anchor point (global position) and the normal of the plane are changed, not * its distance (displacement) to the origin.\n * diff --git a/src/pe/rigidbody/RigidBody.cpp b/src/pe/rigidbody/RigidBody.cpp index b58bcad56..467a36e29 100644 --- a/src/pe/rigidbody/RigidBody.cpp +++ b/src/pe/rigidbody/RigidBody.cpp @@ -27,8 +27,7 @@ namespace pe{ //************************************************************************************************* /*!\brief Constructor for the RigidBody class. * - * \param finite Specifies if the rigid body is finite or not. - * \param visible Specifies if the rigid body is visible or not. + * \param typeID The geometry type of the rigid body. * \param sid The unique system-specific ID of the rigid body. * \param uid The user-specific ID of the rigid body. */ diff --git a/src/pe/rigidbody/RigidBody.h b/src/pe/rigidbody/RigidBody.h index f6d3cfb03..33f23bdee 100644 --- a/src/pe/rigidbody/RigidBody.h +++ b/src/pe/rigidbody/RigidBody.h @@ -2753,13 +2753,12 @@ inline void RigidBody::rotateAroundOriginImpl( const Quat& dq ) /*!\brief Rotation of the rigid body around a specific global coordinate. * * \param point The global center of the rotation. - * \param axis The global rotation axis. - * \param angle The rotation angle (radian measure). + * \param dq The quaternion for the rotation. * \return void * * This function rotates the rigid body around the given global coordinate \a point and changes * both the global position and the orientation/rotation of the rigid body. The rigid body is rotated - * around the given axis \a axis by \a angle degrees (radian measure).\n + * by the quaternion \a dq.\n * * \b Note: * - Rotating a rigid body contained in a union changes the mass distribution and geometry of the diff --git a/src/pe/rigidbody/Squirmer.cpp b/src/pe/rigidbody/Squirmer.cpp index 4a9f714b5..bc25bb5ea 100644 --- a/src/pe/rigidbody/Squirmer.cpp +++ b/src/pe/rigidbody/Squirmer.cpp @@ -38,7 +38,6 @@ namespace pe { * \param sid Unique system-specific ID for the sphere. * \param uid User-specific ID for the sphere. * \param gpos Global geometric center of the sphere. - * \param rpos The relative position within the body frame of a superordinate body. * \param q The orientation of the sphere's body frame in the global world frame. * \param radius The radius of the sphere \f$ (0..\infty) \f$. * \param squirmerVelocity The velocity of the squirmer. diff --git a/src/pe/rigidbody/StorageDataHandling.h b/src/pe/rigidbody/StorageDataHandling.h index 4260f5278..e2e2b7294 100644 --- a/src/pe/rigidbody/StorageDataHandling.h +++ b/src/pe/rigidbody/StorageDataHandling.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BodyStorageDataHandling.h +//! \file StorageDataHandling.h //! \author Sebastian Eibl <sebastian.eibl@fau.de> // //====================================================================================================================== diff --git a/src/pe/rigidbody/Union.h b/src/pe/rigidbody/Union.h index b682f159a..ff1f009d9 100644 --- a/src/pe/rigidbody/Union.h +++ b/src/pe/rigidbody/Union.h @@ -484,7 +484,9 @@ void Union<BodyTypes...>::calcInertia() //************************************************************************************************* /*!\brief Setting the global position of the union. * - * \param gpos The global position. + * \param px The x-component of the global coordinate. + * \param py The y-component of the global coordinate. + * \param pz The z-component of the global coordinate. * \return void * \exception std::logic_error Invalid translation of a global union inside an exclusive section. * @@ -650,7 +652,9 @@ RigidBody& Union<BodyTypes...>::add( std::unique_ptr<RigidBody>&& body ) //************************************************************************************************* /*!\brief Translation of the center of mass of the union by the displacement vector \a dp. * - * \param dp The displacement vector. + * \param dx The displacement on the x-axis. + * \param dy The displacement on the y-axis. + * \param dz The displacement on the z-axis. * \return void * \exception std::logic_error Invalid translation of a global union inside an exclusive section. * @@ -710,16 +714,14 @@ void Union<BodyTypes...>::rotateImpl( const Quat& dq ) //************************************************************************************************* /*!\brief Rotation of the union around the origin of the global world frame. * - * \param xangle Rotation around the x-axis (radian measure). - * \param yangle Rotation around the y-axis (radian measure). - * \param zangle Rotation around the z-axis (radian measure). + * \param dq The quaternion for the rotation. * \return void * \exception std::logic_error Invalid rotation of a global union inside an exclusive section. * * This function rotates the entire union around the origin of the global world frame and * changes both the global position and the orientation/rotation of the union. Additionally, - * all contained rigid bodies change their position and orientation accordingly. The rotations - * are applied in the order x, y, z. The orientation of the bodies within the union in + * all contained rigid bodies change their position and orientation accordingly. + * The orientation of the bodies within the union in * reference to the body frame of the union is not changed. */ template <typename... BodyTypes> @@ -739,8 +741,7 @@ void Union<BodyTypes...>::rotateAroundOriginImpl( const Quat& dq ) /*!\brief Rotation of the union around a specific global coordinate. * * \param point The global center of the rotation. - * \param axis The global rotation axis. - * \param angle The rotation angle (radian measure). + * \param dq The quaternion for the rotation. * \return void * \exception std::logic_error Invalid rotation of a global union inside an exclusive section. * diff --git a/src/pe/synchronization/ClearSynchronization.h b/src/pe/synchronization/ClearSynchronization.h index 2d14c3249..4968bdaa7 100644 --- a/src/pe/synchronization/ClearSynchronization.h +++ b/src/pe/synchronization/ClearSynchronization.h @@ -35,7 +35,7 @@ namespace pe { /*!\brief Removes all synchronization information. * * \param blocks BlockStorage of the simulation. - * \param BlockDataID BlockDataID of the pe storage. + * \param storageID BlockDataID of the pe storage. */ inline void clearSynchronization( BlockStorage& blocks, BlockDataID storageID ) diff --git a/src/pe/synchronization/SyncForces.h b/src/pe/synchronization/SyncForces.h index a99071943..d896b1cd6 100644 --- a/src/pe/synchronization/SyncForces.h +++ b/src/pe/synchronization/SyncForces.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file SynchronizeForces.h +//! \file SyncForces.h //! \author Sebastian Eibl <sebastian.eibl@fau.de> // //====================================================================================================================== diff --git a/src/pe/synchronization/SyncNextNeighbors.h b/src/pe/synchronization/SyncNextNeighbors.h index 4fd166011..594d0a9ed 100644 --- a/src/pe/synchronization/SyncNextNeighbors.h +++ b/src/pe/synchronization/SyncNextNeighbors.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Synchronization.h +//! \file SyncNextNeighbors.h //! \author Sebastian Eibl <sebastian.eibl@fau.de> // //====================================================================================================================== diff --git a/src/pe/utility/Distance.h b/src/pe/utility/Distance.h index 182932591..7fa0981e0 100644 --- a/src/pe/utility/Distance.h +++ b/src/pe/utility/Distance.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file SurfaceDistance.h +//! \file Distance.h //! \author Klaus Iglberger //! \author Sebastian Eibl <sebastian.eibl@fau.de> // diff --git a/src/pe_coupling/geometry/PeOverlapFraction.h b/src/pe_coupling/geometry/PeOverlapFraction.h index f8bae664e..f6a5e209d 100644 --- a/src/pe_coupling/geometry/PeOverlapFraction.h +++ b/src/pe_coupling/geometry/PeOverlapFraction.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file PeOverlapFractions.h +//! \file PeOverlapFraction.h //! \ingroup pe_coupling //! \author Christoph Rettinger <christoph.rettinger@fau.de> // diff --git a/src/pe_coupling/momentum_exchange_method/restoration/PDFReconstruction.h b/src/pe_coupling/momentum_exchange_method/restoration/PDFReconstruction.h index 6de45fbca..bb92f6332 100644 --- a/src/pe_coupling/momentum_exchange_method/restoration/PDFReconstruction.h +++ b/src/pe_coupling/momentum_exchange_method/restoration/PDFReconstruction.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file PDFRestoration.h +//! \file PDFReconstruction.h //! \ingroup pe_coupling //! \author Christoph Rettinger <christoph.rettinger@fau.de> // diff --git a/src/pe_coupling/utility/TimeStep.h b/src/pe_coupling/utility/TimeStep.h index 283282b68..6ff119df6 100644 --- a/src/pe_coupling/utility/TimeStep.h +++ b/src/pe_coupling/utility/TimeStep.h @@ -34,13 +34,13 @@ namespace pe_coupling { /*!\brief Carries out the the PE time steps, including sub iteration functionality. * - * It executes 'numberOfSubIterations' PE steps within one timestep of size 'timeStepSize'. + * It executes \a numberOfSubIterations PE steps within one timestep of size \a timeStepSize. * - * These PE sub iterations require, that the current external (e.g. hydrodynamic, gravitational,..) forces and torques + * These PE sub iterations require, that the current external (e.g. hydrodynamic, gravitational, ...) forces and torques * acting on each particle remains unchanged. Thus, a map is set up internally that stores and re-sets these forces - * and torques in each PE sub iteration - * . - * Additionally, a function 'forceEvaluationFunc' can be given that allows to evaluate different forces before the PE + * and torques in each PE sub iteration. + * + * Additionally, a function \a forceEvaluationFunc can be given that allows to evaluate different forces before the PE * step is carried out. An example are particle-particle lubrication forces that have to be updated in each sub iteration. * */ diff --git a/src/postprocessing/MarchingCubes.impl.h b/src/postprocessing/MarchingCubes.impl.h index 29f22544f..2ac3bfd25 100644 --- a/src/postprocessing/MarchingCubes.impl.h +++ b/src/postprocessing/MarchingCubes.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file MarchingCubes.cpp +//! \file MarchingCubes.impl.h //! \ingroup postprocessing //! \author Martin Bauer <martin.bauer@fau.de> //! \author Simon Bogner <simon.bogner@fau.de> diff --git a/src/python_coupling/CreateConfig.cpp b/src/python_coupling/CreateConfig.cpp index 5f8f9615c..98b61f665 100644 --- a/src/python_coupling/CreateConfig.cpp +++ b/src/python_coupling/CreateConfig.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file CreateConfigFromPythonScript.cpp +//! \file CreateConfig.cpp //! \ingroup python //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/CreateConfig.h b/src/python_coupling/CreateConfig.h index f95d3586e..36fbc2115 100644 --- a/src/python_coupling/CreateConfig.h +++ b/src/python_coupling/CreateConfig.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file CreateConfigFromPythonScript.h +//! \file CreateConfig.h //! \ingroup python //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/PythonWrapper.h b/src/python_coupling/PythonWrapper.h index 3909af052..9e1bfe173 100644 --- a/src/python_coupling/PythonWrapper.h +++ b/src/python_coupling/PythonWrapper.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file python/Python.h +//! \file PythonWrapper.h //! \ingroup core //! \author Matthias Markl <matthias.markl@fau.de> //! \author Martin Bauer <martin.bauer@fau.de> diff --git a/src/python_coupling/export/BasicExport.cpp b/src/python_coupling/export/BasicExport.cpp index 29dd8a493..767a6fd0c 100644 --- a/src/python_coupling/export/BasicExport.cpp +++ b/src/python_coupling/export/BasicExport.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BasicExports.cpp +//! \file BasicExport.cpp //! \ingroup python_coupling //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/export/BasicExport.h b/src/python_coupling/export/BasicExport.h index ba9bb2b07..a786cf12f 100644 --- a/src/python_coupling/export/BasicExport.h +++ b/src/python_coupling/export/BasicExport.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file BasicExports.h +//! \file BasicExport.h //! \ingroup python_coupling //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/export/BlockForestCommunicationExport.h b/src/python_coupling/export/BlockForestCommunicationExport.h index f74ff2fa3..88b6765c5 100644 --- a/src/python_coupling/export/BlockForestCommunicationExport.h +++ b/src/python_coupling/export/BlockForestCommunicationExport.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file CommunicationExport.h +//! \file BlockForestCommunicationExport.h //! \ingroup blockforest //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/export/BlockForestCommunicationExport.impl.h b/src/python_coupling/export/BlockForestCommunicationExport.impl.h index a45abe4ff..3b3c8ed51 100644 --- a/src/python_coupling/export/BlockForestCommunicationExport.impl.h +++ b/src/python_coupling/export/BlockForestCommunicationExport.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file CommunicationExport.impl.h +//! \file BlockForestCommunicationExport.impl.h //! \ingroup blockforest //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/export/BlockForestExport.cpp b/src/python_coupling/export/BlockForestExport.cpp index e4aae6226..a57834b66 100644 --- a/src/python_coupling/export/BlockForestExport.cpp +++ b/src/python_coupling/export/BlockForestExport.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Exports.cpp +//! \file BlockForestExport.cpp //! \ingroup blockforest //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/export/BlockForestExport.h b/src/python_coupling/export/BlockForestExport.h index 1c5ddaae4..641e26ef7 100644 --- a/src/python_coupling/export/BlockForestExport.h +++ b/src/python_coupling/export/BlockForestExport.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Exports.h +//! \file BlockForestExport.h //! \ingroup blockforest //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/export/FieldCommunicationExport.h b/src/python_coupling/export/FieldCommunicationExport.h index ccbe61496..718e325a5 100644 --- a/src/python_coupling/export/FieldCommunicationExport.h +++ b/src/python_coupling/export/FieldCommunicationExport.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file CommunicationExport.h +//! \file FieldCommunicationExport.h //! \ingroup field //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/export/FieldCommunicationExport.impl.h b/src/python_coupling/export/FieldCommunicationExport.impl.h index 57289631d..33a0ac0ee 100644 --- a/src/python_coupling/export/FieldCommunicationExport.impl.h +++ b/src/python_coupling/export/FieldCommunicationExport.impl.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file CommunicationExport.impl.h +//! \file FieldCommunicationExport.impl.h //! \ingroup field //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/export/MPIExport.cpp b/src/python_coupling/export/MPIExport.cpp index 00e13dfdf..ddb3ea025 100644 --- a/src/python_coupling/export/MPIExport.cpp +++ b/src/python_coupling/export/MPIExport.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file MPIExports.cpp +//! \file MPIExport.cpp //! \ingroup python_coupling //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/export/MPIExport.h b/src/python_coupling/export/MPIExport.h index d1653a734..146f39e9a 100644 --- a/src/python_coupling/export/MPIExport.h +++ b/src/python_coupling/export/MPIExport.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file MPIExports.h +//! \file MPIExport.h //! \ingroup python_coupling //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/export/VTKExport.cpp b/src/python_coupling/export/VTKExport.cpp index a8ab00e57..95b699959 100644 --- a/src/python_coupling/export/VTKExport.cpp +++ b/src/python_coupling/export/VTKExport.cpp @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Exports.cpp +//! \file VTKExport.cpp //! \ingroup vtk //! \author Martin Bauer <martin.bauer@fau.de> // diff --git a/src/python_coupling/export/VTKExport.h b/src/python_coupling/export/VTKExport.h index d2f955cd7..edfacf58f 100644 --- a/src/python_coupling/export/VTKExport.h +++ b/src/python_coupling/export/VTKExport.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file Exports.h +//! \file VTKExport.h //! \ingroup vtk //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/helper/BlockStorageExportHelpers.h b/src/python_coupling/helper/BlockStorageExportHelpers.h index 0b41dd498..6a8e79885 100644 --- a/src/python_coupling/helper/BlockStorageExportHelpers.h +++ b/src/python_coupling/helper/BlockStorageExportHelpers.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file ExportHelpers.h +//! \file BlockStorageExportHelpers.h //! \ingroup python_coupling //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/helper/PybindHelper.h b/src/python_coupling/helper/PybindHelper.h index d43c560cc..c305eafd5 100644 --- a/src/python_coupling/helper/PybindHelper.h +++ b/src/python_coupling/helper/PybindHelper.h @@ -14,7 +14,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file CppPythonTypeEquality.h +//! \file PybindHelper.h //! \ingroup python_coupling //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/python_coupling/helper/PythonIterableToStdVector.h b/src/python_coupling/helper/PythonIterableToStdVector.h index 71583ec21..8289aaf0d 100644 --- a/src/python_coupling/helper/PythonIterableToStdVector.h +++ b/src/python_coupling/helper/PythonIterableToStdVector.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file PythonIterableToStdVector.h.h +//! \file PythonIterableToStdVector.h //! \ingroup python_coupling //! \author Martin Bauer <martin.bauer@fau.de> //! \author Markus Holzer <markus.holzer@fau.de> diff --git a/src/sqlite/SQLite.cpp b/src/sqlite/SQLite.cpp index a62fb09af..2670a5c48 100644 --- a/src/sqlite/SQLite.cpp +++ b/src/sqlite/SQLite.cpp @@ -76,7 +76,9 @@ SQLiteDB::~SQLiteDB () * are set to default value ( zero or empty string ). * Additionally a column is created for each activated global state, and its value is set to 1 * - * \param *Properties Map of column names to value + * \param dbHandle Database cursor + * \param filename Database path + * \param integerProperties,stringProperties,realProperties Map of column names to value * \returns The primary key of the inserted data set. */ //******************************************************************************************************************* @@ -158,10 +160,11 @@ uint_t storeRunImpl( sqlite3 * dbHandle, std::string & filename, //******************************************************************************************************************* /*! Stores information in another table, referencing the "run" table * + * \param dbHandle database cursor * \param runId result of storeRun() member function, primary key of the run to store information for * \param tableName name of the table where the information is stored in * is created if it does not yet exist - * \param *Properties Map of column names to value + * \param integerProperties,stringProperties,realProperties Map of column names to value */ //******************************************************************************************************************* template<typename IntType> @@ -231,7 +234,7 @@ void storeAdditionalRunInfoImpl( sqlite3 * dbHandle, * are set to default value ( zero or empty string ). * Additionally a column is created for each activated global state, and its value is set to 1 * - * \param *Properties Map of column names to value + * \param integerProperties,stringProperties,realProperties Map of column names to value * \returns The primary key of the inserted data set. */ //******************************************************************************************************************* @@ -257,7 +260,7 @@ uint_t SQLiteDB::storeRun( const map<string, int64_t> & integerProperties, * \param runId result of storeRun() member function, primary key of the run to store information for * \param tableName name of the table where the information is stored in * is created if it does not yet exist - * \param *Properties Map of column names to value + * \param integerProperties,stringProperties,realProperties Map of column names to value */ //******************************************************************************************************************* void SQLiteDB::storeAdditionalRunInfo( uint_t runId, const std::string & tableName, @@ -285,7 +288,7 @@ void SQLiteDB::storeAdditionalRunInfo( uint_t runId, const std::string & tableNa * * \param runId primary key of the run, as returned by storeRun() * \param tp the TimingPool to store - * \param name name of the timing pool ( as written to database column ) + * \param timingPoolName name of the timing pool ( as written to database column ) */ //******************************************************************************************************************* void SQLiteDB::storeTimingPool ( uint_t runId, @@ -357,7 +360,7 @@ void SQLiteDB::storeTimingPool ( uint_t runId, * * \param runId primary key of the run, as returned by storeRun() * \param tt the TimingTree to store - * \param name name of the timing tree ( as written to database column ) + * \param timingTreeName name of the timing tree ( as written to database column ) */ //******************************************************************************************************************* void SQLiteDB::storeTimingTree ( uint_t runId, @@ -403,7 +406,7 @@ void SQLiteDB::storeTimingTree ( uint_t runId, * \param runId primary key of the run, as returned by storeRun() * \param parentId parent key of the node * \param tn the TimingNode to store - * \param name name of the timing tree ( as written to database column ) + * \param timingTreeName name of the timing tree ( as written to database column ) */ //******************************************************************************************************************* void SQLiteDB::storeTimingNode ( const uint_t runId, diff --git a/src/stencil/Directions.h b/src/stencil/Directions.h index c13d95466..d3a75b812 100644 --- a/src/stencil/Directions.h +++ b/src/stencil/Directions.h @@ -1,6 +1,6 @@ //===================================================================================================================== /*! - * \file Stencil.h + * \file Directions.h * \brief Defines all stencil directions and their properties, and a general DxQy stencil class * \author Martin Bauer <martin.bauer@fau.de> */ diff --git a/src/timeloop/ITimeloop.h b/src/timeloop/ITimeloop.h index 3a77ca995..a2a594702 100644 --- a/src/timeloop/ITimeloop.h +++ b/src/timeloop/ITimeloop.h @@ -13,7 +13,7 @@ // You should have received a copy of the GNU General Public License along // with waLBerla (see COPYING.txt). If not, see <http://www.gnu.org/licenses/>. // -//! \file AbstractTimeloop.h +//! \file ITimeloop.h //! \ingroup timeloop //! \author bauer // diff --git a/src/waLBerlaDefinitions.in.h b/src/waLBerlaDefinitions.in.h index 452d6d8ba..a9622b1e6 100644 --- a/src/waLBerlaDefinitions.in.h +++ b/src/waLBerlaDefinitions.in.h @@ -1,6 +1,6 @@ //====================================================================================================================== /*! - * \file waLBerlaDefinitions.h + * \file waLBerlaDefinitions.in.h * \author Martin Bauer <martin.bauer@fau.de> * \brief Global Definitions configured by cmake ( edit only the *.in.h file! ) */ -- GitLab