Skip to content

Commit

Permalink
Documentation updates
Browse files Browse the repository at this point in the history
  • Loading branch information
peterrum committed Sep 29, 2023
1 parent e3cfd05 commit 13c8ce5
Show file tree
Hide file tree
Showing 2 changed files with 31 additions and 19 deletions.
38 changes: 19 additions & 19 deletions include/deal.II/multigrid/mg_transfer_global_coarsening.h
Original file line number Diff line number Diff line change
Expand Up @@ -103,6 +103,8 @@ namespace mg
};
} // namespace mg



/**
* Global coarsening utility functions.
*/
Expand All @@ -111,7 +113,7 @@ namespace MGTransferGlobalCoarseningTools
/**
* Common polynomial coarsening sequences.
*
* @note These polynomial coarsening sequences up to a degree of 9 are
* @note These polynomial coarsening sequences up to a degree of 6 are
* precompiled in MGTwoLevelTransfer. See also:
* MGTwoLevelTransfer::fast_polynomial_transfer_supported()
*/
Expand Down Expand Up @@ -438,7 +440,7 @@ class MGTwoLevelTransferBase<LinearAlgebra::distributed::Vector<Number>>
/**
* Class for transfer between two multigrid levels for p- or global coarsening.
*
* The implementation of this class is explained in detail in @cite munch2022gc.
* @note For more details, see the template specializations.
*/
template <int dim, typename VectorType>
class MGTwoLevelTransfer : public MGTwoLevelTransferBase<VectorType>
Expand Down Expand Up @@ -487,7 +489,8 @@ class MGTwoLevelTransfer : public MGTwoLevelTransferBase<VectorType>
* Class for transfer between two multigrid levels for p- or global coarsening.
* Specialization for LinearAlgebra::distributed::Vector.
*
* The implementation of this class is explained in detail in @cite munch2022gc.
* The implementation of this class is explained in detail in @cite munch2022gc
* and in step-75.
*/
template <int dim, typename Number>
class MGTwoLevelTransfer<dim, LinearAlgebra::distributed::Vector<Number>>
Expand All @@ -498,8 +501,7 @@ class MGTwoLevelTransfer<dim, LinearAlgebra::distributed::Vector<Number>>
public:
/**
* Set up global coarsening between the given DoFHandler objects (
* @p dof_handler_fine and @p dof_handler_coarse). The transfer
* can be only performed on active levels.
* @p dof_handler_fine and @p dof_handler_coarse).
*/
void
reinit_geometric_transfer(
Expand All @@ -519,7 +521,8 @@ class MGTwoLevelTransfer<dim, LinearAlgebra::distributed::Vector<Number>>
* or on coarse-grid levels, i.e., levels without hanging nodes.
*
* @note The function polynomial_transfer_supported() can be used to
* check if the given polynomial coarsening strategy is supported.
* check whether fast evaluation of the given polynomial coarsening
* strategy is supported.
*/
void
reinit_polynomial_transfer(
Expand All @@ -538,8 +541,8 @@ class MGTwoLevelTransfer<dim, LinearAlgebra::distributed::Vector<Number>>
* underlying Triangulation objects polynomial or geometrical global
* coarsening is performed.
*
* @note While geometric transfer can be only performed on active levels
* (`numbers::invalid_unsigned_int`), polynomial transfers can also be
* @note While geometric transfer can be performed on active levels
* and any multigrid level, polynomial transfers can only be
* performed on coarse-grid levels, i.e., levels without hanging nodes.
*
* @note The function polynomial_transfer_supported() can be used to
Expand All @@ -561,7 +564,7 @@ class MGTwoLevelTransfer<dim, LinearAlgebra::distributed::Vector<Number>>
*
* @note Currently, the polynomial coarsening strategies: 1) go-to-one,
* 2) bisect, and 3) decrease-by-one are precompiled with templates for
* degrees up to 9.
* degrees up to 6.
*/
static bool
fast_polynomial_transfer_supported(const unsigned int fe_degree_fine,
Expand Down Expand Up @@ -793,11 +796,7 @@ class MGTwoLevelTransferNonNested<dim,
*/
AdditionalData(const double tolerance = 1e-6,
const unsigned int rtree_level = 0,
const bool enforce_all_points_found = true)
: tolerance(tolerance)
, rtree_level(rtree_level)
, enforce_all_points_found(enforce_all_points_found)
{}
const bool enforce_all_points_found = true);

/**
* Tolerance parameter. See the constructor of RemotePointEvaluation for
Expand Down Expand Up @@ -1004,7 +1003,8 @@ class MGTwoLevelTransferNonNested<dim,
* for systems involving multiple components of one of these elements. Other
* elements are currently not implemented.
*
* The implementation of this class is explained in detail in @cite munch2022gc.
* The implementation of this class is explained in detail in @cite munch2022gc
* and in step-75.
*/
template <int dim, typename Number>
class MGTransferMF : public dealii::MGLevelGlobalTransfer<
Expand All @@ -1024,7 +1024,7 @@ class MGTransferMF : public dealii::MGLevelGlobalTransfer<
MGTransferMF() = default;

/**
* @name Global coarsening.
* @name Global coarsening
*/
/** @{ */

Expand Down Expand Up @@ -1073,7 +1073,7 @@ class MGTransferMF : public dealii::MGLevelGlobalTransfer<
/** @} */

/**
* @name Local smoothing.
* @name Local smoothing
*/
/** @{ */

Expand Down Expand Up @@ -1117,7 +1117,7 @@ class MGTransferMF : public dealii::MGLevelGlobalTransfer<
/** @} */

/**
* @name Transfer functions.
* @name Transfer functions
*/
/** @{ */

Expand Down Expand Up @@ -1200,7 +1200,7 @@ class MGTransferMF : public dealii::MGLevelGlobalTransfer<
/** @} */

/**
* @name Utility functions.
* @name Utility functions
*/
/** @{ */

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -5409,6 +5409,18 @@ MGTwoLevelTransferNonNested<dim, LinearAlgebra::distributed::Vector<Number>>::
}



template <int dim, typename Number>
MGTwoLevelTransferNonNested<dim, LinearAlgebra::distributed::Vector<Number>>::
AdditionalData::AdditionalData(const double tolerance,
const unsigned int rtree_level,
const bool enforce_all_points_found)
: tolerance(tolerance)
, rtree_level(rtree_level)
, enforce_all_points_found(enforce_all_points_found)
{}


DEAL_II_NAMESPACE_CLOSE

#endif

0 comments on commit 13c8ce5

Please sign in to comment.