Skip to content

Commit

Permalink
Comments: correct some typos (#3641)
Browse files Browse the repository at this point in the history
## Summary

This PR fixes some typos and spelling errors in the comments that
codespell seems to have missed.
  • Loading branch information
eebasso committed Nov 27, 2023
1 parent 60b45bc commit 4b64003
Show file tree
Hide file tree
Showing 20 changed files with 36 additions and 36 deletions.
6 changes: 3 additions & 3 deletions CHANGES
Original file line number Diff line number Diff line change
Expand Up @@ -72,7 +72,7 @@

-- We weren't defining cent_hat out far enough (#3548)

-- Add Fortran inteface for FillCoarsePatch for face variables (#3542)
-- Add Fortran interface for FillCoarsePatch for face variables (#3542)

-- print_state/printCell: Make it work without managed memory (#3543)

Expand Down Expand Up @@ -114,7 +114,7 @@

-- Simplify filterParticles Kernel (#3510)

-- Generatize particle-to-cell assignment function (#3499)
-- Generalize particle-to-cell assignment function (#3499)
Follow-on to 3499 (#3514)
ParticleLocator: Make Assignor optional template parameter (#3515)

Expand Down Expand Up @@ -302,7 +302,7 @@

# 23.07

-- Allow users to change the default vector growth stategy (#3389)
-- Allow users to change the default vector growth strategy (#3389)

-- Communications arena implementation (#3388)

Expand Down
8 changes: 4 additions & 4 deletions Src/AmrCore/AMReX_FillPatcher.H
Original file line number Diff line number Diff line change
Expand Up @@ -15,13 +15,13 @@ namespace amrex {
* with interpolation of the coarse data. Then it fills the fine ghost
* cells overlapping fine level valid cells with the fine level data. If
* the valid cells of the destination need to be filled, it will be done as
* well. Finally, it will fill the physical bounbary using the user
* well. Finally, it will fill the physical boundary using the user
* provided functor. The `fill` member function can be used to do the
* operations just described. Alternatively, one can also use the
* `fillCoarseFineBounary` to fill the ghost cells at the coarse/fine
* boundary only. Then one can manually call FillBoundary to fill the other
* ghost cells, and use the physical BC functor to handle the physical
* boundeary.
* boundary.
*
* The communication of the coarse data needed for spatial interpolation is
* optimized at the cost of being error-prone. One must follow the
Expand All @@ -42,7 +42,7 @@ namespace amrex {
*
* (3) When to destroy? Usually, we do time steppig on a coarse level
* first. Then we recursively do time stepping on fine levels. After the
* finer level finishes, we do reflux and averge the fine data down to the
* finer level finishes, we do reflux and average the fine data down to the
* coarse level. After that we should destroy the FillPatcher object
* associated with these two levels, because the coarse data stored in the
* object has become outdated. For AmrCore based codes, you could use
Expand Down Expand Up @@ -118,7 +118,7 @@ public:
* \param fbc for filling fine level physical BC
* \param fbccomp starting component of the fine level BC functor
* \param bcs BCRec specifying physical boundary types
* \parame bcscomp starting component of the BCRec Vector.
* \param bcscomp starting component of the BCRec Vector.
* \param pre_interp optional pre-interpolation hook for modifying the coarse data
* \param post_interp optional post-interpolation hook for modifying the fine data
*/
Expand Down
4 changes: 2 additions & 2 deletions Src/AmrCore/AMReX_InterpFaceRegister.H
Original file line number Diff line number Diff line change
Expand Up @@ -10,7 +10,7 @@ namespace amrex {

/**
* \brief InterpFaceRegister is a coarse/fine boundary register for
* interpolation of face data at the coarse/fine boundadry.
* interpolation of face data at the coarse/fine boundary.
*/

class InterpFaceRegister
Expand All @@ -31,7 +31,7 @@ public:
Geometry const& fgeom, IntVect const& ref_ratio);

/**
* \brief Defines an InterpFaceRegister objecct.
* \brief Defines an InterpFaceRegister object.
*
* \param fba The fine level BoxArray
* \param fdm The fine level DistributionMapping
Expand Down
2 changes: 1 addition & 1 deletion Src/Base/AMReX_BCRec.H
Original file line number Diff line number Diff line change
Expand Up @@ -43,7 +43,7 @@ public:
{}
/*
* \brief Yet another constructor. Inherits bndry types from bc_domain
* when bx lies on edge of domain otherwise gets interior Dirchlet.
* when bx lies on edge of domain otherwise gets interior Dirichlet.
*/
AMREX_GPU_HOST_DEVICE
BCRec (const Box& bx,
Expand Down
2 changes: 1 addition & 1 deletion Src/Base/AMReX_FArrayBox.H
Original file line number Diff line number Diff line change
Expand Up @@ -116,7 +116,7 @@ public:
* \brief Pure virtual function. Derived classes MUST override this
* function to skip over the next FAB f in the istream, under the
* assumption that the header for the FAB f has already been
* skpped over.
* skipped over.
*/
virtual void skip (std::istream& is,
FArrayBox& f) const = 0;
Expand Down
4 changes: 2 additions & 2 deletions Src/Base/AMReX_FabArray.H
Original file line number Diff line number Diff line change
Expand Up @@ -339,7 +339,7 @@ public:

/**
* \brief Construct an empty FabArray<FAB> that has a default Arena. If
* `define` is called later with a nulltpr as MFInfo's arena, the
* `define` is called later with a nullptr as MFInfo's arena, the
* default Arena `a` will be used. If the arena in MFInfo is not a
* nullptr, the MFInfo's arena will be used.
*/
Expand Down Expand Up @@ -2827,7 +2827,7 @@ template <class FAB>
void
FabArray<FAB>::shift (const IntVect& v)
{
clearThisBD(); // The new boxarry will have a different ID.
clearThisBD(); // The new boxarray will have a different ID.
boxarray.shift(v);
addThisBD();
#ifdef AMREX_USE_OMP
Expand Down
4 changes: 2 additions & 2 deletions Src/Base/AMReX_MultiFab.H
Original file line number Diff line number Diff line change
Expand Up @@ -50,7 +50,7 @@ public:
/**
* \brief Constructs an empty MultiFab. Data can be defined at a later
* time using the define member functions inherited from FabArray. If
* `define` is called later with a nulltpr as MFInfo's arena, the default
* `define` is called later with a nullptr as MFInfo's arena, the default
* Arena `a` will be used. If the arena in MFInfo is not a nullptr, the
* MFInfo's arena will be used.
*/
Expand All @@ -60,7 +60,7 @@ public:
* \brief
* Constructs a MultiFab
* \param bs a valid region
* \param dm a DistribuionMapping
* \param dm a DistributionMapping
* \param ncomp number of components
* \param ngrow number of cells the region grows
* \param info MFInfo
Expand Down
2 changes: 1 addition & 1 deletion Src/Base/AMReX_MultiFabUtil.H
Original file line number Diff line number Diff line change
Expand Up @@ -375,7 +375,7 @@ namespace amrex
void FillRandom (MultiFab& mf, int scomp, int ncomp);

/**
* \brief Fill MultiFab with random numbers from nornmal distribution
* \brief Fill MultiFab with random numbers from normal distribution
*
* All cells including ghost cells are filled.
*
Expand Down
2 changes: 1 addition & 1 deletion Src/Base/AMReX_MultiFabUtil.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -477,7 +477,7 @@ namespace amrex
auto tmptype = type;
tmptype.set(dir);
if (dir >= AMREX_SPACEDIM || !tmptype.nodeCentered()) {
amrex::Abort("average_down_edges: not face index type");
amrex::Abort("average_down_edges: not edge index type");
}
const int ncomp = crse.nComp();
if (isMFIterSafe(fine, crse))
Expand Down
4 changes: 2 additions & 2 deletions Src/Base/AMReX_iMultiFab.H
Original file line number Diff line number Diff line change
Expand Up @@ -24,7 +24,7 @@ namespace amrex {
* member functions are defined for I/O and simple arithmetic operations on
* these aggregate objects.
*
8 This class does NOT provide a copy constructor or assignment operator.
* This class does NOT provide a copy constructor or assignment operator.
*/
class iMultiFab
:
Expand All @@ -42,7 +42,7 @@ public:
/**
* \brief Constructs an empty iMultiFab. Data can be defined at a later
* time using the define member functions inherited from FabArray. If
* `define` is called later with a nulltpr as MFInfo's arena, the default
* `define` is called later with a nullptr as MFInfo's arena, the default
* Arena `a` will be used. If the arena in MFInfo is not a nullptr, the
* MFInfo's arena will be used.
*/
Expand Down
2 changes: 1 addition & 1 deletion Src/EB/AMReX_EB_utils.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -31,7 +31,7 @@ facets_nearest_pt (IntVect const& ind_pt, IntVect const& ind_loop, RealVect cons
RealVect const& eb_normal, RealVect const& eb_p0,
GpuArray<Real,AMREX_SPACEDIM> const& dx)
{
// Enumerate the possible EB facet edges invovlved.
// Enumerate the possible EB facet edges involved.
int n_facets = 0;
IntVect ind_facets {AMREX_D_DECL(0, 0, 0)};
for (int d = 0; d < AMREX_SPACEDIM; ++d) {
Expand Down
2 changes: 1 addition & 1 deletion Src/F_Interfaces/Base/AMReX_parallel_mod.F90
Original file line number Diff line number Diff line change
Expand Up @@ -71,7 +71,7 @@ subroutine amrex_parallel_init (comm)

if (present(comm) .and. .not.flag) then
if (comm .ne. MPI_COMM_WORLD) then
stop "MPI has not been initialized. How come we are given a communciator?"
stop "MPI has not been initialized. How come we are given a communicator?"
endif
end if

Expand Down
10 changes: 5 additions & 5 deletions Src/LinearSolvers/MLMG/AMReX_MLABecLaplacian.H
Original file line number Diff line number Diff line change
Expand Up @@ -72,7 +72,7 @@ public:

/**
* Sets alpha as a scalar field to values from a single component
* mutlifab.
* multifab.
*
* \param [in] amrlev The level of the multifab for the solver, with
* \p amrlev = 0 always being the lowest level in the
Expand All @@ -88,12 +88,12 @@ public:

/**
* Sets alpha as a single scalar constant value across
* the mutlifab.
* the multifab.
*
* \param [in] amrlev The level of the multifab for the solver, with
* \p amrlev = 0 always being the lowest level in the
* AMR hierarchy represented in the solve.
* \param [in] alpha Single scalar value to populate across mutlifab.
* \param [in] alpha Single scalar value to populate across multifab.
*/
template <typename T,
std::enable_if_t<std::is_convertible_v<T,typename MF::value_type>,
Expand All @@ -118,12 +118,12 @@ public:

/**
* Sets beta as a single scalar constant value across
* the mutlifabs (one for each dimension).
* the multifabs (one for each dimension).
*
* \param [in] amrlev The level of the multifab for the solver, with
* \p amrlev = 0 always being the lowest level in the
* AMR hierarchy represented in the solve.
* \param [in] beta Single scalar value to populate across mutlifabs.
* \param [in] beta Single scalar value to populate across multifabs.
*/
template <typename T,
std::enable_if_t<std::is_convertible_v<T,typename MF::value_type>,
Expand Down
2 changes: 1 addition & 1 deletion Src/LinearSolvers/MLMG/AMReX_MLEBNodeFDLaplacian.H
Original file line number Diff line number Diff line change
Expand Up @@ -18,7 +18,7 @@ namespace amrex {
// where phi and rhs are nodal multifab, and sigma is a tensor constant
// with only diagonal components. The EB is assumed to be Dirichlet.
//
// del dot (simga grad phi) - alpha/r^2 phi = rhs, for RZ where alpha is a
// del dot (sigma grad phi) - alpha/r^2 phi = rhs, for RZ where alpha is a
// scalar constant that is zero by default.

class MLEBNodeFDLaplacian
Expand Down
2 changes: 1 addition & 1 deletion Src/LinearSolvers/MLMG/AMReX_MLLinOp.H
Original file line number Diff line number Diff line change
Expand Up @@ -287,7 +287,7 @@ public:
* \param famrlev fine AMR level
* \param fine fine level data
* \param crse coarse level data
* \parame nghost number of ghost cells
* \param nghost number of ghost cells
*/
virtual void interpolationAmr (int famrlev, MF& fine, const MF& crse,
IntVect const& nghost) const = 0;
Expand Down
2 changes: 1 addition & 1 deletion Src/LinearSolvers/MLMG/AMReX_MLMG.H
Original file line number Diff line number Diff line change
Expand Up @@ -1370,7 +1370,7 @@ MLMGT<MF>::mgFcycle ()
}
}

// At the true bottom of the coarset AMR level.
// At the true bottom of the coarsest AMR level.
// in : Residual (res) as b
// out : Correction (cor) as x
template <typename MF>
Expand Down
8 changes: 4 additions & 4 deletions Src/LinearSolvers/MLMG/AMReX_MLNodeLap_2D_K.H
Original file line number Diff line number Diff line change
Expand Up @@ -2406,7 +2406,7 @@ void mlndlap_fillijmat_aa_cpu (Box const& ndbx,
Real f2xmy = Real(2.0)*facx - facy;
Real fmx2y = Real(2.0)*facy - facx;

// Note that ccdom has been grown at peridoci boundaries.
// Note that ccdom has been grown at periodic boundaries.
const Box& nddom = amrex::surroundingNodes(ccdom);

constexpr auto gidmax = std::numeric_limits<AtomicInt>::max();
Expand Down Expand Up @@ -2552,7 +2552,7 @@ void mlndlap_fillijmat_ha_cpu (Box const& ndbx,
Real facx = Real(1.0/6.0)*dxinv[0]*dxinv[0];
Real facy = Real(1.0/6.0)*dxinv[1]*dxinv[1];

// Note that ccdom has been grown at peridoci boundaries.
// Note that ccdom has been grown at periodic boundaries.
const Box& nddom = amrex::surroundingNodes(ccdom);

constexpr auto gidmax = std::numeric_limits<AtomicInt>::max();
Expand Down Expand Up @@ -2708,7 +2708,7 @@ void mlndlap_fillijmat_cs_cpu (Box const& ndbx,
Real f2xmy = Real(2.0)*facx - facy;
Real fmx2y = Real(2.0)*facy - facx;

// Note that ccdom has been grown at peridoci boundaries.
// Note that ccdom has been grown at periodic boundaries.
const Box& nddom = amrex::surroundingNodes(ccdom);

constexpr auto gidmax = std::numeric_limits<AtomicInt>::max();
Expand Down Expand Up @@ -3355,7 +3355,7 @@ void mlndlap_fillijmat_cs_gpu (const int ps, const int i, const int j, const int
fp = fm = Real(0.0);
}

// Note that nddom has been grown at peridoci boundaries.
// Note that nddom has been grown at periodic boundaries.
const Box& nddom = amrex::surroundingNodes(ccdom);

constexpr auto gidmax = std::numeric_limits<AtomicInt>::max();
Expand Down
2 changes: 1 addition & 1 deletion Src/LinearSolvers/MLMG/AMReX_MLNodeLaplacian.H
Original file line number Diff line number Diff line change
Expand Up @@ -6,7 +6,7 @@

namespace amrex {

// del dot (sigma grah phi) = rhs
// del dot (sigma grad phi) = rhs
// where phi and rhs are nodal, and sigma is cell-centered.

class MLNodeLaplacian
Expand Down
2 changes: 1 addition & 1 deletion Src/LinearSolvers/MLMG/AMReX_MLNodeLaplacian.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -947,7 +947,7 @@ MLNodeLaplacian::checkPoint (std::string const& file_name) const

HeaderFile.precision(17);

// MLLinop stuff
// MLLinOp stuff
HeaderFile << "verbose = " << verbose << "\n"
<< "nlevs = " << NAMRLevels() << "\n"
<< "do_agglomeration = " << info.do_agglomeration << "\n"
Expand Down
2 changes: 1 addition & 1 deletion Src/LinearSolvers/MLMG/AMReX_MLNodeLinOp.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -234,7 +234,7 @@ void MLNodeLinOp_set_dot_mask (MultiFab& dot_mask, iMultiFab const& omask, Geome
Box nddomain = amrex::surroundingNodes(geom.Domain());

if (strategy != MLNodeLinOp::CoarseningStrategy::Sigma) {
nddomain.grow(1000); // hack to avoid masks being modified at Neuman boundary
nddomain.grow(1000); // hack to avoid masks being modified at Neumann boundary
}

#ifdef AMREX_USE_OMP
Expand Down

0 comments on commit 4b64003

Please sign in to comment.