diff --git a/packages/anasazi/src/AnasaziDenseMatTraits.hpp b/packages/anasazi/src/AnasaziDenseMatTraits.hpp index a557c59be677..7a4727d771f2 100644 --- a/packages/anasazi/src/AnasaziDenseMatTraits.hpp +++ b/packages/anasazi/src/AnasaziDenseMatTraits.hpp @@ -124,8 +124,8 @@ namespace Anasazi { \return The return value is a pointer to the data, stored sequentially. \c *cor denotes whether the data is stored column-oriented (\f$*cor == - true$) or row-oriented (\f$cor == false$). \c *stride denotes the stride - between columns/rows. + true\f$) or row-oriented (\f$cor == false\f$). \c *stride denotes the stride + between columns/rows. */ static ScalarType * values( DM& dm, int *stride, bool *cor) { diff --git a/packages/ifpack2/src/Ifpack2_Details_AdditiveSchwarzFilter_decl.hpp b/packages/ifpack2/src/Ifpack2_Details_AdditiveSchwarzFilter_decl.hpp index 9546fbc0a9da..905fdc56decf 100644 --- a/packages/ifpack2/src/Ifpack2_Details_AdditiveSchwarzFilter_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_Details_AdditiveSchwarzFilter_decl.hpp @@ -108,7 +108,7 @@ namespace Details void updateMatrixValues(); Teuchos::RCP getFilteredMatrix() const; - + //! Destructor. virtual ~AdditiveSchwarzFilter (); @@ -294,7 +294,7 @@ namespace Details //! Returns the Frobenius norm of the matrix. /** Computes and returns the Frobenius norm of the matrix, defined as: - \f$ \|A\|_F = \sqrt{\sum_{i,j} \|\a_{ij}\|^2} \f$ + \f$ \|A\|_F = \sqrt{\sum_{i,j} \|a_{ij}\|^2} \f$ */ virtual mag_type getFrobeniusNorm() const; @@ -403,4 +403,3 @@ namespace Details }} //namespace Ifpack2::Details #endif - diff --git a/packages/ifpack2/src/Ifpack2_Details_DenseSolver_decl.hpp b/packages/ifpack2/src/Ifpack2_Details_DenseSolver_decl.hpp index 16ebd243039c..17534bef192a 100644 --- a/packages/ifpack2/src/Ifpack2_Details_DenseSolver_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_Details_DenseSolver_decl.hpp @@ -133,7 +133,7 @@ class DenseSolver : /// \brief Apply the preconditioner to X, putting the result in Y. /// /// If the result of applying this preconditioner to a vector X is - /// \f$M^{-1} \cdot X$, then this method computes \f$\beta Y + \alpha M^{-1} \cdot X\f$. + /// \f$M^{-1} \cdot X\f$, then this method computes \f$\beta Y + \alpha M^{-1} \cdot X\f$. /// The typical case is \f$\beta = 0\f$ and \f$\alpha = 1\f$. void apply (const Tpetra::MultiVector& X, @@ -388,7 +388,7 @@ class DenseSolver : /// \brief Apply the preconditioner to X, putting the result in Y. /// /// If the result of applying this preconditioner to a vector X is - /// \f$M^{-1} \cdot X$, then this method computes \f$\beta Y + \alpha M^{-1} \cdot X\f$. + /// \f$M^{-1} \cdot X\f$, then this method computes \f$\beta Y + \alpha M^{-1} \cdot X\f$. /// The typical case is \f$\beta = 0\f$ and \f$\alpha = 1\f$. void apply (const Tpetra::MultiVector& X, diff --git a/packages/ifpack2/src/Ifpack2_Details_TriDiSolver_decl.hpp b/packages/ifpack2/src/Ifpack2_Details_TriDiSolver_decl.hpp index 4abe55392c4a..5a171550cb0c 100644 --- a/packages/ifpack2/src/Ifpack2_Details_TriDiSolver_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_Details_TriDiSolver_decl.hpp @@ -131,7 +131,7 @@ class TriDiSolver : /// \brief Apply the preconditioner to X, putting the result in Y. /// /// If the result of applying this preconditioner to a vector X is - /// \f$M^{-1} \cdot X$, then this method computes \f$\beta Y + \alpha M^{-1} \cdot X\f$. + /// \f$M^{-1} \cdot X\f$, then this method computes \f$\beta Y + \alpha M^{-1} \cdot X\f$. /// The typical case is \f$\beta = 0\f$ and \f$\alpha = 1\f$. void apply (const Tpetra::MultiVector& X, @@ -387,7 +387,7 @@ class TriDiSolver : /// \brief Apply the preconditioner to X, putting the result in Y. /// /// If the result of applying this preconditioner to a vector X is - /// \f$M^{-1} \cdot X$, then this method computes \f$\beta Y + \alpha M^{-1} \cdot X\f$. + /// \f$M^{-1} \cdot X\f$, then this method computes \f$\beta Y + \alpha M^{-1} \cdot X\f$. /// The typical case is \f$\beta = 0\f$ and \f$\alpha = 1\f$. void apply (const Tpetra::MultiVector& X, diff --git a/packages/ifpack2/src/Ifpack2_DiagonalFilter_decl.hpp b/packages/ifpack2/src/Ifpack2_DiagonalFilter_decl.hpp index 0bd1886dd89e..368748817a73 100644 --- a/packages/ifpack2/src/Ifpack2_DiagonalFilter_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_DiagonalFilter_decl.hpp @@ -129,7 +129,7 @@ class DiagonalFilter : //! \brief Returns the maximum number of entries across all rows/columns on this node. virtual size_t getLocalMaxNumRowEntries() const; - + //! The number of degrees of freedom per mesh point. virtual LocalOrdinal getBlockSize () const; @@ -251,7 +251,7 @@ class DiagonalFilter : //! Returns the Frobenius norm of the matrix. /** Computes and returns the Frobenius norm of the matrix, defined as: - \f$ \|A\|_F = \sqrt{\sum_{i,j} \|\a_{ij}\|^2} \f$ + \f$ \|A\|_F = \sqrt{\sum_{i,j} \|a_{ij}\|^2} \f$ */ virtual mag_type getFrobeniusNorm() const; diff --git a/packages/ifpack2/src/Ifpack2_Diagonal_decl.hpp b/packages/ifpack2/src/Ifpack2_Diagonal_decl.hpp index 5cf4445ab9a1..8e84cc31c410 100644 --- a/packages/ifpack2/src/Ifpack2_Diagonal_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_Diagonal_decl.hpp @@ -163,7 +163,7 @@ class Diagonal : /// \brief Apply the preconditioner to X, putting the result in Y. /// /// If the result of applying this preconditioner to a vector X is - /// \f$F \cdot X$, then this method computes \f$\beta Y + \alpha F \cdot X\f$. + /// \f$F \cdot X\f$, then this method computes \f$\beta Y + \alpha F \cdot X\f$. /// The typical case is \f$\beta = 0\f$ and \f$\alpha = 1\f$. void apply (const Tpetra::MultiVector& X, diff --git a/packages/ifpack2/src/Ifpack2_DropFilter_decl.hpp b/packages/ifpack2/src/Ifpack2_DropFilter_decl.hpp index 30ceeec12bdf..7f19007936da 100644 --- a/packages/ifpack2/src/Ifpack2_DropFilter_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_DropFilter_decl.hpp @@ -131,7 +131,7 @@ class DropFilter : //! \brief Returns the maximum number of entries across all rows/columns on this node. virtual size_t getLocalMaxNumRowEntries() const; - + //! The number of degrees of freedom per mesh point. virtual LocalOrdinal getBlockSize () const; @@ -253,7 +253,7 @@ class DropFilter : //! Returns the Frobenius norm of the matrix. /** Computes and returns the Frobenius norm of the matrix, defined as: - \f$ \|A\|_F = \sqrt{\sum_{i,j} \|\a_{ij}\|^2} \f$ + \f$ \|A\|_F = \sqrt{\sum_{i,j} \|a_{ij}\|^2} \f$ */ virtual mag_type getFrobeniusNorm() const; diff --git a/packages/ifpack2/src/Ifpack2_OverlappingRowMatrix_decl.hpp b/packages/ifpack2/src/Ifpack2_OverlappingRowMatrix_decl.hpp index df00305a5d5b..1d6f8ca20fa1 100644 --- a/packages/ifpack2/src/Ifpack2_OverlappingRowMatrix_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_OverlappingRowMatrix_decl.hpp @@ -160,7 +160,7 @@ class OverlappingRowMatrix : //! The maximum number of entries in any row on the calling process. virtual size_t getLocalMaxNumRowEntries() const; - + //! The number of degrees of freedom per mesh point. virtual local_ordinal_type getBlockSize () const; @@ -283,7 +283,7 @@ class OverlappingRowMatrix : //! Returns the Frobenius norm of the matrix. /** Computes and returns the Frobenius norm of the matrix, defined as: - \f$ \|A\|_F = \sqrt{\sum_{i,j} \|\a_{ij}\|^2} \f$ + \f$ \|A\|_F = \sqrt{\sum_{i,j} \|a_{ij}\|^2} \f$ */ virtual mag_type getFrobeniusNorm () const; diff --git a/packages/ifpack2/src/Ifpack2_Preconditioner.hpp b/packages/ifpack2/src/Ifpack2_Preconditioner.hpp index a4fc523c7c5e..a14c1d2d688b 100644 --- a/packages/ifpack2/src/Ifpack2_Preconditioner.hpp +++ b/packages/ifpack2/src/Ifpack2_Preconditioner.hpp @@ -100,7 +100,7 @@ class Preconditioner : /// @brief Apply the preconditioner to X, putting the result in Y. /// /// If the result of applying this preconditioner to a vector X is - /// \f$F \cdot X$\f$, then this method computes \f$\beta Y + \alpha F \cdot X\f$. + /// \f$F \cdot X\f$, then this method computes \f$\beta Y + \alpha F \cdot X\f$. /// The typical case is \f$\beta = 0\f$ and \f$\alpha = 1\f$. virtual void apply (const Tpetra::MultiVector &X, diff --git a/packages/ifpack2/src/Ifpack2_Relaxation_decl.hpp b/packages/ifpack2/src/Ifpack2_Relaxation_decl.hpp index 060494d979ac..37bcdaa0d076 100644 --- a/packages/ifpack2/src/Ifpack2_Relaxation_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_Relaxation_decl.hpp @@ -147,7 +147,7 @@ iteration $k+1$ of whatever relaxation method we are using. Here, The Richardson method computes \f[ -x^{(k+1)}_i = x_^{(k)}_i + alpha ( b_i - \sum_{j} A_{ij} x^{(k)}_j ). +x^{(k+1)}_i = x^{(k)}_i + alpha ( b_i - \sum_{j} A_{ij} x^{(k)}_j ). \f] The Jacobi method computes diff --git a/packages/ifpack2/src/Ifpack2_ReorderFilter_decl.hpp b/packages/ifpack2/src/Ifpack2_ReorderFilter_decl.hpp index d4bd7eb5492d..dd88344346fc 100644 --- a/packages/ifpack2/src/Ifpack2_ReorderFilter_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_ReorderFilter_decl.hpp @@ -273,7 +273,7 @@ class ReorderFilter : //! Returns the Frobenius norm of the matrix. /** Computes and returns the Frobenius norm of the matrix, defined as: - \f$ \|A\|_F = \sqrt{\sum_{i,j} \|\a_{ij}\|^2} \f$ + \f$ \|A\|_F = \sqrt{\sum_{i,j} \|a_{ij}\|^2} \f$ */ virtual mag_type getFrobeniusNorm() const; diff --git a/packages/ifpack2/src/Ifpack2_SingletonFilter_decl.hpp b/packages/ifpack2/src/Ifpack2_SingletonFilter_decl.hpp index 34f64dfe0bb6..b710bee15072 100644 --- a/packages/ifpack2/src/Ifpack2_SingletonFilter_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_SingletonFilter_decl.hpp @@ -238,7 +238,7 @@ class SingletonFilter : //! Returns the Frobenius norm of the matrix. /** Computes and returns the Frobenius norm of the matrix, defined as: - \f$ \|A\|_F = \sqrt{\sum_{i,j} \|\a_{ij}\|^2} \f$ + \f$ \|A\|_F = \sqrt{\sum_{i,j} \|a_{ij}\|^2} \f$ */ virtual mag_type getFrobeniusNorm() const; diff --git a/packages/ifpack2/src/Ifpack2_SparsityFilter_decl.hpp b/packages/ifpack2/src/Ifpack2_SparsityFilter_decl.hpp index 91f6884dc6bf..082b591260e4 100644 --- a/packages/ifpack2/src/Ifpack2_SparsityFilter_decl.hpp +++ b/packages/ifpack2/src/Ifpack2_SparsityFilter_decl.hpp @@ -258,7 +258,7 @@ class SparsityFilter : //! Returns the Frobenius norm of the matrix. /** Computes and returns the Frobenius norm of the matrix, defined as: - \f$ \|A\|_F = \sqrt{\sum_{i,j} \|\a_{ij}\|^2} \f$ + \f$ \|A\|_F = \sqrt{\sum_{i,j} \|a_{ij}\|^2} \f$ */ virtual mag_type getFrobeniusNorm() const; diff --git a/packages/intrepid2/src/Cell/Intrepid2_CellTools.hpp b/packages/intrepid2/src/Cell/Intrepid2_CellTools.hpp index a9eb6cab7145..dca068f6b332 100644 --- a/packages/intrepid2/src/Cell/Intrepid2_CellTools.hpp +++ b/packages/intrepid2/src/Cell/Intrepid2_CellTools.hpp @@ -21,7 +21,7 @@ #include "Shards_CellTopology.hpp" #include "Shards_BasicTopologies.hpp" -#include "Teuchos_RCP.hpp" +#include "Teuchos_RCP.hpp" #include "Intrepid2_Types.hpp" #include "Intrepid2_Utils.hpp" @@ -91,10 +91,10 @@ namespace Intrepid2 { private: - /** \brief Generates default HGrad basis based on cell topology - \param cellTopo [in] - cell topology + /** \brief Generates default HGrad basis based on cell topology + \param cellTopo [in] - cell topology */ - template static Teuchos::RCP > createHGradBasis( const shards::CellTopology cellTopo ) { @@ -129,7 +129,7 @@ namespace Intrepid2 { case shards::ShellTriangle<6>::key: case shards::ShellQuadrilateral<4>::key: case shards::ShellQuadrilateral<8>::key: - case shards::ShellQuadrilateral<9>::key: + case shards::ShellQuadrilateral<9>::key: default: { INTREPID2_TEST_FOR_EXCEPTION( true, std::invalid_argument, ">>> ERROR (Intrepid2::CellTools::createHGradBasis): Cell topology not supported."); @@ -174,7 +174,7 @@ namespace Intrepid2 { \mbox{jacobian}(c,p,i,j) = [DF_{c}(\mbox{points}(c,p))]_{ij} \quad c=0,\ldots, C \f] - Requires pointer to HGrad basis that defines reference to physical cell mapping. + Requires pointer to HGrad basis that defines reference to physical cell mapping. See Section \ref sec_cell_topology_ref_map_DF for definition of the Jacobian. \warning @@ -199,7 +199,7 @@ namespace Intrepid2 { const WorksetType worksetCell, const Teuchos::RCP basis, const int startCell=0, const int endCell=-1); - + /** \brief Computes the Jacobian matrix \e DF of the reference-to-physical frame map \e F. There are two use cases: @@ -242,7 +242,7 @@ namespace Intrepid2 { const WorksetType worksetCell, const BasisGradientsType gradients, const int startCell=0, const int endCell=-1); - + /** \brief Computes the Jacobian matrix \e DF of the reference-to-physical frame map \e F. There are two use cases: @@ -287,9 +287,9 @@ namespace Intrepid2 { const shards::CellTopology cellTopo ) { using nonConstPointValueType = typename PointViewType::non_const_value_type; auto basis = createHGradBasis(cellTopo); - setJacobian(jacobian, - points, - worksetCell, + setJacobian(jacobian, + points, + worksetCell, basis); } @@ -349,7 +349,7 @@ namespace Intrepid2 { template static void setJacobianDet( Data & jacobianDet, const Data & jacobian); - + /** \brief Computes reciprocals of determinants corresponding to the Jacobians in the Data container provided \param jacobianDetInv [out] - data with shape (C,P), as returned by CellTools::allocateJacobianDet() @@ -367,7 +367,7 @@ namespace Intrepid2 { template static void setJacobianInv( Data & jacobianInv, const Data & jacobian); - + /** \brief Multiplies the Jacobian with shape (C,P,D,D) by the reciprocals of the determinants, with shape (C,P), entrywise. \param jacobianDividedByDet [out] - data container with shape (C,P,D,D), as returned by CellTools::allocateJacobianInv() @@ -378,7 +378,7 @@ namespace Intrepid2 { static void setJacobianDividedByDet( Data & jacobianDividedByDet, const Data & jacobian, const Data & jacobianDetInv); - + //============================================================================================// // // // Node information // @@ -393,7 +393,7 @@ namespace Intrepid2 { Requires cell topology with a reference cell. \param cellCenter [out] - coordinates of the specified reference cell center - \param cell [in] - cell topology + \param cell [in] - cell topology */ template static void @@ -581,7 +581,6 @@ namespace Intrepid2 { (\hat{x}(t),\hat{y}(t)) & \mbox{for 2D parent cells} \\[1ex] (\hat{x}(u,v),\hat{y}(u,v),\hat{z}(u,v)) & \mbox{for 3D parent cells} \end{array}\right. - \f] For sides of 2D cells \e R=[-1,1] and for sides of 3D cells \f[ @@ -978,8 +977,8 @@ namespace Intrepid2 { This corresponds to mapping multiple sets of reference points to a matching number of physical cells. - Requires pointer to HGrad basis that defines reference to physical cell mapping. - See Section \ref sec_cell_topology_ref_map for definition of the mapping function. + Requires pointer to HGrad basis that defines reference to physical cell mapping. + See Section \ref sec_cell_topology_ref_map for definition of the mapping function. \warning The array \c refPoints represents an arbitrary set of points in the reference @@ -1055,9 +1054,9 @@ namespace Intrepid2 { const shards::CellTopology cellTopo ) { using nonConstRefPointValueType = typename RefPointViewType::non_const_value_type; auto basis = createHGradBasis(cellTopo); - mapToPhysicalFrame(physPoints, - refPoints, - worksetCell, + mapToPhysicalFrame(physPoints, + refPoints, + worksetCell, basis); } @@ -1124,7 +1123,7 @@ namespace Intrepid2 { /** \brief Computes parameterization maps of 1- and 2-subcells of reference cells. - Overload of the previous function (see explanation above) where the subcell parametrization is used instead of + Overload of the previous function (see explanation above) where the subcell parametrization is used instead of passing the parent cell topology. */ @@ -1160,7 +1159,7 @@ namespace Intrepid2 { Applies \f$ F^{-1}_{c} \f$ for \b all cells in a cell workset to \b multiple point sets having the same number of points, indexed by cell ordinal, and stored in a rank-3 - (C,P,D) array. Returns a rank-3 (C,P,D) array such that + (C,P,D) array. Returns a rank-3 (C,P,D) array such that \f[ \mbox{refPoints}(c,p,d) = \Big(F^{-1}_c(physPoint(c,p,*)) \Big)_d \f] @@ -1212,13 +1211,13 @@ namespace Intrepid2 { Applies \f$ F^{-1}_{c} \f$ for \b all cells in a cell workset to \b multiple point sets having the same number of points, indexed by cell ordinal, and stored in a rank-3 - (C,P,D) array. Returns a rank-3 (C,P,D) array such that + (C,P,D) array. Returns a rank-3 (C,P,D) array such that \f[ \mbox{refPoints}(c,p,d) = \Big(F^{-1}_c(physPoint(c,p,*)) \Big)_d \f] - Requires pointer to HGrad basis that defines reference to physical cell mapping. - See Section \ref sec_cell_topology_ref_map for definition of the mapping function. + Requires pointer to HGrad basis that defines reference to physical cell mapping. + See Section \ref sec_cell_topology_ref_map for definition of the mapping function. \warning The array \c physPoints represents an arbitrary set (or sets) of points in the physical @@ -1251,7 +1250,7 @@ namespace Intrepid2 { Applies \f$ F^{-1}_{c} \f$ for \b all cells in a cell workset to \b multiple point sets having the same number of points, indexed by cell ordinal, and stored in a rank-3 - (C,P,D) array. Returns a rank-3 (C,P,D) array such that + (C,P,D) array. Returns a rank-3 (C,P,D) array such that \f[ \mbox{refPoints}(c,p,d) = \Big(F^{-1}_c(physPoint(c,p,*)) \Big)_d \f] @@ -1376,11 +1375,11 @@ namespace Intrepid2 { */ template - static void - getSubcvCoords( Kokkos::DynRankView subcvCoords, + static void + getSubcvCoords( Kokkos::DynRankView subcvCoords, const Kokkos::DynRankView cellCoords, const shards::CellTopology primaryCell ); - + //============================================================================================// // // // Inclusion tests // @@ -1388,19 +1387,19 @@ namespace Intrepid2 { //============================================================================================// /** \brief Checks if a point belongs to a reference cell. - + Requires cell topology with a reference cell. - + \param point [in] - rank-1 view (D) of the point tested for inclusion - \param cellTopo [in] - cell topology + \param cellTopo [in] - cell topology \param threshold [in] - "tightness" of the inclusion test \return true if the point is in the closure of the specified reference cell and false otherwise. */ template - static bool + static bool checkPointInclusion( const PointViewType point, const shards::CellTopology cellTopo, - const typename ScalarTraits::scalar_type thres = + const typename ScalarTraits::scalar_type thres = threshold::scalar_type>() ); @@ -1410,34 +1409,34 @@ namespace Intrepid2 { or to multiple sets indexed by a cell ordinal and stored in a rank-3 view (C,P,D). The cell topology key is a template argument. Requires cell topology with a reference cell. - \param inCell [out] - rank-1 view (P) or rank-2 view (C,P). On return, its entries will be set to 1 or 0 depending on whether points are included in cells + \param inCell [out] - rank-1 view (P) or rank-2 view (C,P). On return, its entries will be set to 1 or 0 depending on whether points are included in cells \param point [in] - rank-2 view (P,D) or rank-3 view (C,P,D) with reference coordinates of the points tested for inclusion \param threshold [in] - "tightness" of the inclusion test */ template - static void checkPointwiseInclusion( OutputViewType inCell, + static void checkPointwiseInclusion( OutputViewType inCell, const InputViewType points, const typename ScalarTraits::scalar_type thresh = - threshold::scalar_type>()); + threshold::scalar_type>()); /** \brief Checks every point in multiple sets indexed by a cell ordinal for inclusion in the reference cell of a given topology. - Requires cell topology with a reference cell. + Requires cell topology with a reference cell. \param inRefCell [out] - rank-2 view (C,P) with results from the pointwise inclusion test \param refPoints [in] - rank-3 view (C,P,D) \param cellTopo [in] - cell topology \param threshold [in] - "tightness" of the inclusion test */ - template - static void checkPointwiseInclusion( InCellViewType inCell, - const PointViewType points, - const shards::CellTopology cellTopo, - const typename ScalarTraits::scalar_type thres = + static void checkPointwiseInclusion( InCellViewType inCell, + const PointViewType points, + const shards::CellTopology cellTopo, + const typename ScalarTraits::scalar_type thres = threshold::scalar_type>() ); /** \brief Checks every points for inclusion in physical cells from a cell workset. @@ -1451,14 +1450,14 @@ namespace Intrepid2 { \param cellTopo [in] - cell topology \param threshold [in] - tolerance for inclusion tests on the input points */ - template - static void checkPointwiseInclusion( Kokkos::DynRankView inCell, - const Kokkos::DynRankView points, - const Kokkos::DynRankView cellWorkset, - const shards::CellTopology cellTopo, - const typename ScalarTraits::scalar_type thres = + template + static void checkPointwiseInclusion( Kokkos::DynRankView inCell, + const Kokkos::DynRankView points, + const Kokkos::DynRankView cellWorkset, + const shards::CellTopology cellTopo, + const typename ScalarTraits::scalar_type thres = threshold::scalar_type>() ); @@ -1557,8 +1556,8 @@ namespace Intrepid2 { \param cellWorkset [in] - rank-3 (C,N,D) array required \param cellTopo [in] - cell topology with a reference cell required */ - template static void CellTools_mapToReferenceFrameArgs( const refPointViewType refPoints, @@ -1575,9 +1574,9 @@ namespace Intrepid2 { \param cellWorkset [in] - rank-3 (C,N,D) array required \param cellTopo [in] - cell topology with a reference cell required */ - template static void CellTools_mapToReferenceFrameInitGuess( const refPointViewType refPoints, @@ -1603,4 +1602,3 @@ namespace Intrepid2 { #endif - diff --git a/packages/muelu/src/Transfers/BlockedTransfers/MueLu_BlockedPFactory_decl.hpp b/packages/muelu/src/Transfers/BlockedTransfers/MueLu_BlockedPFactory_decl.hpp index e9123956203b..94da01f90cf3 100644 --- a/packages/muelu/src/Transfers/BlockedTransfers/MueLu_BlockedPFactory_decl.hpp +++ b/packages/muelu/src/Transfers/BlockedTransfers/MueLu_BlockedPFactory_decl.hpp @@ -26,7 +26,7 @@ namespace MueLu { @brief Factory for building blocked, segregated prolongation operators. Factory for building blocked, segregated prolongation operators of the form - \f$ P=\diag(P_{11},P_{22},\ldots)\f$, where \f$ P_{ii}\f$ are prolongation operators + \f$ P=\\operatorname{diag}(P_{11},P_{22},\ldots)\f$, where \f$ P_{ii}\f$ are prolongation operators for the corresponding subblocks \f$A_{ii}\f$ in the blocked operator \f$ A \f$. @param RCP AFact = Teuchos::null: factory for generating blocked operator \f$ A\f$. diff --git a/packages/rol/example/gross-pitaevskii/example_02.hpp b/packages/rol/example/gross-pitaevskii/example_02.hpp index d9e1c5f95aa8..007e9fb18712 100644 --- a/packages/rol/example/gross-pitaevskii/example_02.hpp +++ b/packages/rol/example/gross-pitaevskii/example_02.hpp @@ -663,8 +663,8 @@ class Normalization_Constraint : public Constraint { (*ahuvp)[i] = 2.0*dx_*(*vp)[i]*(*up)[0]; } } - - /** Solve the system \f[ \begin{\pmatrix} K & c'^\ast(\psi)\\ c'(\psi) & 0 \end{pmatrix} + + /** Solve the system \f[ \begin{pmatrix} K & c'^\ast(\psi)\\ c'(\psi) & 0 \end{pmatrix} * \begin{pmatrix} v_1\\v_2 \end{pmatrix}=\begin{pmatrix} b_1\\b_2\end{pmatrix}\f] * In this example, \f$K\f$ is the finite difference Laplacian the constraint is a * scalar and the Jacobian is a vector and the exact inverse can be computed using the diff --git a/packages/rol/src/algorithm/TypeB/pqn/ROL_PQNObjective.hpp b/packages/rol/src/algorithm/TypeB/pqn/ROL_PQNObjective.hpp index dcbe8e247342..561ae3161b9f 100644 --- a/packages/rol/src/algorithm/TypeB/pqn/ROL_PQNObjective.hpp +++ b/packages/rol/src/algorithm/TypeB/pqn/ROL_PQNObjective.hpp @@ -20,7 +20,7 @@ This class implements the PQN quasi-Newton objective for use with ROL::TypeB::QuasiNewtonAlgorithm. Given a function \f$f:\mathcal{X}\to\mathbb{R}\f$ and a Hessian approximation - \f$B_k:\mathcal{X}}\to\mathcal{X}^*\f$, the functional is + \f$B_k:\mathcal{X}\to\mathcal{X}^*\f$, the functional is \f[ q_k(x) = \frac{1}{2}\langle B_k (x-x_k),(x-x_k)\rangle_{\mathcal{X}^*,\mathcal{X}} + \langle f'(x_k), (x-x_k)\rangle_{\mathcal{X}^*,\mathcal{X}}. diff --git a/packages/rol/src/algorithm/TypeG/stabilizedlcl/ROL_ElasticObjective.hpp b/packages/rol/src/algorithm/TypeG/stabilizedlcl/ROL_ElasticObjective.hpp index e4a5d2a2e2e1..ec5351fc6443 100644 --- a/packages/rol/src/algorithm/TypeG/stabilizedlcl/ROL_ElasticObjective.hpp +++ b/packages/rol/src/algorithm/TypeG/stabilizedlcl/ROL_ElasticObjective.hpp @@ -25,7 +25,7 @@ L_A(x,\lambda,\mu) = f(x) + \langle \lambda, c(x)\rangle_{\mathcal{C}^*,\mathcal{C}} + \frac{\mu}{2} \langle \mathfrak{R}c(x),c(x)\rangle_{\mathcal{C}^*,\mathcal{C}} - + \sigma\langle \mathfrak{R} e, u-v\ranlge_{\mathcal{C}^*,\mathcal{C}} + + \sigma\langle \mathfrak{R} e, u-v\rangle_{\mathcal{C}^*,\mathcal{C}} \f] where \f$\lambda\in\mathcal{C}^*\f$ denotes the Lagrange multiplier estimate, \f$\mu > 0\f$ and \f$\sigma>0\f$ are penalty parameters, diff --git a/packages/rol/src/function/dynamic/ROL_DynamicTrackingFEMObjective.hpp b/packages/rol/src/function/dynamic/ROL_DynamicTrackingFEMObjective.hpp index 7fe89fbdee3d..c07a7207756a 100644 --- a/packages/rol/src/function/dynamic/ROL_DynamicTrackingFEMObjective.hpp +++ b/packages/rol/src/function/dynamic/ROL_DynamicTrackingFEMObjective.hpp @@ -20,8 +20,8 @@ \brief Defines the time-local contribution to a quadratic tracking objective - \f[ f_k(u,z) = \frac{1}{2} \int\limits_{t_{k-1}}^{t_k} \| u(t)-\tilde u(t)\|^2 - + \alpha \|z(t)\^2\,\mathm{d}t \f] + \f[ f_k(u,z) = \frac{1}{2} \int\limits_{t_{k-1}}^{t_k} \| u(t)-\tilde u(t)\|^2 + + \alpha \|z(t)^2\,\mathrm{d}t \f] Currently approximates the state disparity norm using linear finite elements which couples the old and new state contributions diff --git a/packages/rol/src/function/dynamic/ROL_DynamicTrackingObjective.hpp b/packages/rol/src/function/dynamic/ROL_DynamicTrackingObjective.hpp index 268847deb6a1..4881ccf408c0 100644 --- a/packages/rol/src/function/dynamic/ROL_DynamicTrackingObjective.hpp +++ b/packages/rol/src/function/dynamic/ROL_DynamicTrackingObjective.hpp @@ -20,8 +20,8 @@ \brief Defines the time-local contribution to a quadratic tracking objective - \f[ f_k(u,z) = \frac{1}{2} \int\limits_{t_{k-1}}^{t_k} \| u(t)-\tilde u(t)\|^2 - + \alpha \|z(t)\^2\,\mathm{d}t \f] + \f[ f_k(u,z) = \frac{1}{2} \int\limits_{t_{k-1}}^{t_k} \| u(t)-\tilde u(t)\|^2 + + \alpha \|z(t)^2\,\mathrm{d}t \f] Currently approximates the integral with the trapezoidal rule. diff --git a/packages/rol/src/function/operator/ROL_HouseholderReflector.hpp b/packages/rol/src/function/operator/ROL_HouseholderReflector.hpp index 39f3e9c58f88..da56ddcdfb86 100644 --- a/packages/rol/src/function/operator/ROL_HouseholderReflector.hpp +++ b/packages/rol/src/function/operator/ROL_HouseholderReflector.hpp @@ -26,7 +26,7 @@ where \f[ - \hat u = x + \sign(\langle x,u\rangle)\frac{||x||}{||y||}y,\quad u = \frac{\hat u}{||\hat u||} + \hat u = x + \operatorname{sign}(\langle x,u\rangle)\frac{||x||}{||y||}y,\quad u = \frac{\hat u}{||\hat u||} \f] If y is not specified, it is taken to be the first canonical vector diff --git a/packages/rol/src/function/operator/ROL_SchurComplement.hpp b/packages/rol/src/function/operator/ROL_SchurComplement.hpp index a3dc61e9e00d..5d6dbe8aac00 100644 --- a/packages/rol/src/function/operator/ROL_SchurComplement.hpp +++ b/packages/rol/src/function/operator/ROL_SchurComplement.hpp @@ -24,12 +24,12 @@ namespace ROL { Let \f$Mx=b\f$ where \f[ M = \begin{pmatrix} A & B \\ C & D \end{pmatrix} \f] \f[ x = \begin{pmatrix} y & z \end{pmatrix} \f] - \f[ b = \begin{pmayrix} u & v \end{pmatrix} \f] + \f[ b = \begin{pmatrix} u & v \end{pmatrix} \f] The block factorization is \f$ M=USL \f$ where \f[ U = \begin{pmatrix} I & BD^{-1} \\ 0 & I \end{pmatrix} \f] - \f[ S = \begin{pmatrix} A-BD^{-1}C & 0 \\ 0 & D \end{pmatrix} \f] - \f[ L = \begin{pmatrix} I & 0 \\ D^{-1} C & I \f] + \f[ S = \begin{pmatrix} A-BD^{-1}C & 0 \\ 0 & D \end{pmatrix} \f] + \f[ L = \begin{pmatrix} I & 0 \\ D^{-1} C & I \end{pmatrix} \f] We can rewrite \f$ USLx=b\f$ as the block-decoupled problem \f$ Sw=c \f$ where \f$w=Lx\f$ and \f$ c=U^{-1}b \f$ diff --git a/packages/rol/src/function/std/ROL_StdTridiagonalOperator.hpp b/packages/rol/src/function/std/ROL_StdTridiagonalOperator.hpp index 64c589b9a7ba..f0c5010a4ebf 100644 --- a/packages/rol/src/function/std/ROL_StdTridiagonalOperator.hpp +++ b/packages/rol/src/function/std/ROL_StdTridiagonalOperator.hpp @@ -17,7 +17,7 @@ \brief Provides the std::vector implementation to apply a linear operator, which encapsulates a tridiagonal matrix - \f[ T = \begin{matrix} + \f[ T = \begin{pmatrix} a_0 & b_0 \\ c_0 & a_1 & b_1 \\ & c_1 & \ddots & \ddots \\ diff --git a/packages/rol/src/sol/function/randvarfunctional/risk/ROL_MeanSemiDeviation.hpp b/packages/rol/src/sol/function/randvarfunctional/risk/ROL_MeanSemiDeviation.hpp index f7e3650aa158..e99fe17ba634 100644 --- a/packages/rol/src/sol/function/randvarfunctional/risk/ROL_MeanSemiDeviation.hpp +++ b/packages/rol/src/sol/function/randvarfunctional/risk/ROL_MeanSemiDeviation.hpp @@ -23,7 +23,6 @@ \f[ \mathcal{R}(X) = \mathbb{E}[X] + c \mathbb{E}\left[(X-\mathbb{E}[X])_+\right] - \right\} \f] where \f$(x)_+ = \max\{0,x\}\f$. \f$\mathcal{R}\f$ is a law-invariant coherent risk measure. diff --git a/packages/rol/src/sol/function/randvarfunctional/risk/ROL_MeanSemiDeviationFromTarget.hpp b/packages/rol/src/sol/function/randvarfunctional/risk/ROL_MeanSemiDeviationFromTarget.hpp index 18b8c07303fb..744fbfbdfbfc 100644 --- a/packages/rol/src/sol/function/randvarfunctional/risk/ROL_MeanSemiDeviationFromTarget.hpp +++ b/packages/rol/src/sol/function/randvarfunctional/risk/ROL_MeanSemiDeviationFromTarget.hpp @@ -23,7 +23,6 @@ \f[ \mathcal{R}(X) = \mathbb{E}[X] + c \mathbb{E}\left[(X-t)_+\right] - \right\} \f] where \f$(x)_+ = \max\{0,x\}\f$. \f$\mathcal{R}\f$ is a law-invariant risk measure. diff --git a/packages/rol/src/step/interiorpoint/ROL_PrimalDualInteriorPointReducedResidual.hpp b/packages/rol/src/step/interiorpoint/ROL_PrimalDualInteriorPointReducedResidual.hpp index a9aafee7bfa9..375b90abeda9 100644 --- a/packages/rol/src/step/interiorpoint/ROL_PrimalDualInteriorPointReducedResidual.hpp +++ b/packages/rol/src/step/interiorpoint/ROL_PrimalDualInteriorPointReducedResidual.hpp @@ -38,7 +38,7 @@ c \\ (x-l)z_l - \mu e \\ (u-x)z_u - \mu e - \end{pmatrix} = -\begin{pmatrix} g_x \\ g_\lambda \\ g_{z_l} \\ g_{z_u} + \end{pmatrix} = -\begin{pmatrix} g_x \\ g_\lambda \\ g_{z_l} \\ g_{z_u} \end{pmatrix} \f] Using the last two equations, we have diff --git a/packages/rol/src/zoo/ROL_Types.hpp b/packages/rol/src/zoo/ROL_Types.hpp index a349ba91ba94..7b45c927815e 100644 --- a/packages/rol/src/zoo/ROL_Types.hpp +++ b/packages/rol/src/zoo/ROL_Types.hpp @@ -528,7 +528,7 @@ namespace ROL { \arg DANIEL \f$ \frac{g_{k+1}^\top \nabla^2 f(x_k) d_k}{d_k^\top \nabla^2 f(x_k) d_k} \f$ \arg POLAK_RIBIERE \f$ \frac{g_{k+1}^\top y_k}{\|g_k\|^2} \f$ \arg FLETCHER_CONJDESC \f$ -\frac{\|g_{k+1}\|^2}{d_k^\top g_k} \f$ - \arg LIU_STOREY \f$ -\frac{g_k^\top y_{k-1} }{d_{k-1}^\top g_{k-1} \f$ + \arg LIU_STOREY \f$ -\frac{g_k^\top y_{k-1} }{d_{k-1}^\top g_{k-1}} \f$ \arg DAI_YUAN \f$ \frac{\|g_{k+1}\|^2}{d_k^\top y_k} \f$ \arg HAGER_ZHANG \f$ \frac{g_{k+1}^\top y_k}{d_k^\top y_k} - 2 \frac{\|y_k\|^2}{d_k^\top y_k} \frac{g_{k+1}^\top d_k}{d_k^\top y_k} \f$ \arg OREN_LUENBERGER \f$ \frac{g_{k+1}^\top y_k}{d_k^\top y_k} - \frac{\|y_k\|^2}{d_k^\top y_k} \frac{g_{k+1}^\top d_k}{d_k^\top y_k} \f$ diff --git a/packages/rol/test/function/test_18.cpp b/packages/rol/test/function/test_18.cpp index 862fe59b25d9..95e2aec05b49 100644 --- a/packages/rol/test/function/test_18.cpp +++ b/packages/rol/test/function/test_18.cpp @@ -12,11 +12,11 @@ Compose the objective \f$f(y)\f$ where \f$y = g(x)\f$ with - \f[ + \f{align*}{ y_1 &= g_1(x) &= x_1^2 + x_2^2 + x_3^2 + x_4^2 + x_5^2 - 10 \\ y_2 &= g_2(x) &= x_2*x_3 - 5*x_4*x_5 \\ y_3 &= g_3(x) &= x_1^3 + x_2^3 + 1 - \f] + \f} and diff --git a/packages/stokhos/src/Stokhos_JacobiBasis.hpp b/packages/stokhos/src/Stokhos_JacobiBasis.hpp index 8a43dab04ce1..37642da91919 100644 --- a/packages/stokhos/src/Stokhos_JacobiBasis.hpp +++ b/packages/stokhos/src/Stokhos_JacobiBasis.hpp @@ -19,7 +19,7 @@ namespace Stokhos { * Jacobi polynomials are defined by the recurrence relationship * \f[ * A_k \psi_{k+1}(x) = \left(B_k-x C_k\right) - * \psi_k(x) - D_k \psi_{k-1}(x)\right) + * \psi_k(x) - D_k \psi_{k-1}(x) * \f] * with \f$\psi_{-1}(x) = 0\f$ and \f$\psi_{0}(x) = 1\f$ * where @@ -37,9 +37,9 @@ namespace Stokhos { * \f] * In Stokhos notation we have * \f[ \gamma_{k+1}=1/A_{k} \f] - * \f[ \alpha_k = B_k \] - * \f[ \delta_k = C_k \] - * \f[ \beta_k = D_k. \] + * \f[ \alpha_k = B_k \f] + * \f[ \delta_k = C_k \f] + * \f[ \beta_k = D_k. \f] * * The corresponding * density function is diff --git a/packages/stokhos/src/Stokhos_Lanczos.hpp b/packages/stokhos/src/Stokhos_Lanczos.hpp index 35fa4ddbbbcb..2c43c7b6b90a 100644 --- a/packages/stokhos/src/Stokhos_Lanczos.hpp +++ b/packages/stokhos/src/Stokhos_Lanczos.hpp @@ -72,7 +72,7 @@ namespace Stokhos { * applies the Lanczos procedure to compute an orthogonal basis for the * Krylov subspace * \f[ - * \mathcal{K}(A, u_0, k) = \{ u_0, A_u_0, A^2 u_0, \dots, A^k u_0 \}. + * \mathcal{K}(A, u_0, k) = \{ u_0, A u_0, A^2 u_0, \dots, A^k u_0 \}. * \f] * The basis vectors are given by * \f[ diff --git a/packages/thyra/core/example/operator_vector/ExampleTridiagSerialLinearOp.hpp b/packages/thyra/core/example/operator_vector/ExampleTridiagSerialLinearOp.hpp index c4557bcf80f9..226d081c59aa 100644 --- a/packages/thyra/core/example/operator_vector/ExampleTridiagSerialLinearOp.hpp +++ b/packages/thyra/core/example/operator_vector/ExampleTridiagSerialLinearOp.hpp @@ -22,7 +22,6 @@ * of the form: * \f[ - M= \left[\begin{array}{ccccc} d_{(1)} & u_{(1)} \\ diff --git a/packages/thyra/core/example/operator_vector/ExampleTridiagSpmdLinearOp.hpp b/packages/thyra/core/example/operator_vector/ExampleTridiagSpmdLinearOp.hpp index bf952460b39f..c6ccb1e05e22 100644 --- a/packages/thyra/core/example/operator_vector/ExampleTridiagSpmdLinearOp.hpp +++ b/packages/thyra/core/example/operator_vector/ExampleTridiagSpmdLinearOp.hpp @@ -23,7 +23,6 @@ * of the global form: * \f[ - M= \left[\begin{array}{ccccc} d_{(1)} & u_{(1)} \\ @@ -49,7 +48,6 @@ * following sub-matrix is stored: * \f[ - \left[\begin{array}{cccccc} d_{(1)} & u_{(1)} \\ l_{(1)} & d_{(2)} & u_{(2)} \\ @@ -69,7 +67,6 @@ * sub-matrix is stored: * \f[ - \left[\begin{array}{cccccc} l_{(g_i)} & d_{(g_i+1)} & u_{(g_i+1)} \\ & \ddots & \ddots & \ddots \\ @@ -87,7 +84,6 @@ * stored: * \f[ - \left[\begin{array}{cccccc} l_{(g_{N-1})} & d_{(g_{N-1}+1)} & u_{(g_{N-1}+1)} \\ & \ddots & \ddots & \ddots \\ diff --git a/packages/thyra/doc/groups.doc b/packages/thyra/doc/groups.doc index a61fc001bebd..133b1409ed16 100644 --- a/packages/thyra/doc/groups.doc +++ b/packages/thyra/doc/groups.doc @@ -283,7 +283,7 @@ subclasses are shown below: subclass that represent the implicit addition of two or more constituent Thyra::LinearOpBase objects of the form - \f$M =\; A_0 + A_1 + \ldots + A_{m-1}}\f$ + \f$M =\; A_0 + A_1 + \ldots + A_{m-1}\f$ composed out of one or more constituent linear operators \f$A_0, A_1 \ldots A_{m-1}\f$. @@ -292,7 +292,7 @@ subclasses are shown below: subclass that defines a composite multiplicative Thyra::LinearOpBase of the form - \f$M =\; A_0 A_1 \ldots A_{m-1}}\f$ + \f$M =\; A_0 A_1 \ldots A_{m-1}\f$ composed out of one or more constituent linear operators \f$A_0, A_1 \ldots A_{m-1}\f$. diff --git a/packages/tpetra/core/src/Tpetra_RowMatrix_decl.hpp b/packages/tpetra/core/src/Tpetra_RowMatrix_decl.hpp index 640b165a597a..383f38e389c5 100644 --- a/packages/tpetra/core/src/Tpetra_RowMatrix_decl.hpp +++ b/packages/tpetra/core/src/Tpetra_RowMatrix_decl.hpp @@ -84,7 +84,7 @@ namespace Tpetra { /// certain Scalar types. using mag_type = typename Kokkos::ArithTraits::mag_type; - typedef typename + typedef typename Kokkos::View::const_type values_device_view_type; typedef typename values_device_view_type::HostMirror::const_type @@ -391,7 +391,7 @@ namespace Tpetra { /// This method computes and returns the Frobenius norm of the /// matrix. The Frobenius norm \f$\|A\|_F\f$ for the matrix /// \f$A\f$ is defined as - /// \f$\|A\|_F = \sqrt{ \sum_{i,j} |\a_{ij}|^2 }\f$. + /// \f$\|A\|_F = \sqrt{ \sum_{i,j} |a_{ij}|^2 }\f$. /// It has the same value as the Euclidean norm of a vector made /// by stacking the columns of \f$A\f$. virtual mag_type getFrobeniusNorm() const = 0; @@ -502,4 +502,3 @@ namespace Tpetra { } // namespace Tpetra #endif // TPETRA_ROWMATRIX_DECL_HPP -