By agreement with NIMA unedited SRTM-1 data for the United States and its
territories and possessions are also being released and can be found in
the directory /United_States_1arcsec./ Cells that straddle the border with
-neighboring countries have been masked with quarter degree quantiation
+neighboring countries have been masked with quarter degree quantization
such that data outside the U.S. have the void value.
2.3 Elevation mosaics
// the current executor from scheduling more tasks, but it is
// unrelated to the tasks of the scheduler for which we are
// waiting for something, and so that other executor will
- // eventually get arond to scheduling the task we are waiting
+ // eventually get around to scheduling the task we are waiting
// for, at which point the current task will also complete.
future.wait();
/**
* Evaluate the dependent functions that were registered at
- * initializtion time.
+ * initialization time.
*
* The @p output_values are the numerical result of substituting
* each of the @p substitution_values for their corresponding entry
/**
* Evaluate the dependent function that were registered at
- * initializtion time.
+ * initialization time.
*
* The purpose of this function is the same as the other call()
* functions, but
/**
* Return a flag that describes whether this operator can return the
* computation of the infinity norm. Since in general this is not the
- * case, this always returns a negetive result.
+ * case, this always returns a negative result.
*
* This overloads the same function from the Trilinos class
* Epetra_Operator.
* @param add_boundary_indices Add boundary indices.
* @param add_refinement_edge_indices Add refinement-edge indices.
* @param add_level_constraints Add level constraints including the one passed
- * during initialize() and periodicy constraints.
+ * during initialize() and periodicity constraints.
* @param add_user_constraints Add user constraints.
*/
template <typename Number>
"sync. The class requires that the number of dataset keys is the same as "
"the number of independent values sets and mesh linked value sets. The "
"number of each of these is allowed to differ by one to allow new values "
- "to be added with out restricting the order the user choses to do so. "
+ "to be added without restricting the order the user chooses to do so. "
"Special cases of no FHandler and no independent values should not "
"trigger this error.");
* processes. The finest level of information is given by the leaves, which in
* this context would be the collection of all the bounding boxes associated
* to the locally owned cells of the triangulation. Exchanging this information
- * with all participating processes would defeat the purpuse of parallel
+ * with all participating processes would defeat the purpose of parallel
* computations. If however one constructs an RTree containing these bounding
* boxes (for example, by calling
* GridTools::Cache::get_cell_bounding_boxes_rtree()), and then extracts one of
// check that the name of the FE
// and the name of the FE that we
// re-create from this name are
- // identitical. this is also a
+ // identical. this is also a
// pretty good indication that the
// two FEs are actually the same
deallog << fe1.get_name();
// check that the name of the FE
// and the name of the FE that we
// re-create from this name are
- // identitical. this is also a
+ // identical. this is also a
// pretty good indication that the
// two FEs are actually the same
deallog << modify_name<dim>(fe1.get_name());
// check that the name of the FE
// and the name of the FE that we
// re-create from this name are
- // identitical. this is also a
+ // identical. this is also a
// pretty good indication that the
// two FEs are actually the same
deallog << modify_name<dim>(fe1.get_name());
const double left = 0;
const double right = 1;
- auto add_periodicy = [&](dealii::Triangulation<dim> &tria) {
+ auto add_periodicity = [&](dealii::Triangulation<dim> &tria) {
std::vector<
GridTools::PeriodicFacePair<typename Triangulation<dim>::cell_iterator>>
periodic_faces;
// create serial triangulation
Triangulation<dim> basetria;
GridGenerator::subdivided_hyper_cube(basetria, n_subdivisions);
- // new: add periodicy on serial mesh
- add_periodicy(basetria);
+ // new: add periodicity on serial mesh
+ add_periodicity(basetria);
basetria.refine_global(n_refinements);
GridTools::partition_triangulation_zorder(
// actually create triangulation
tria_pft.create_triangulation(construction_data);
- // new: add periodicy on fullydistributed mesh (!!!)
- add_periodicy(tria_pft);
+ // new: add periodicity on fullydistributed mesh (!!!)
+ add_periodicity(tria_pft);
// test triangulation
FE_Q<dim> fe(2);
// Read the file back and change the physical group description to be
// unrecognizable.
std::ifstream input(mesh_filename, std::ifstream::in);
- std::stringstream buffert;
- buffert << input.rdbuf();
- std::string filecontent = buffert.str();
+ std::stringstream buffer;
+ buffer << input.rdbuf();
+ std::string filecontent = buffer.str();
input.close();
boost::replace_all(filecontent, "MaterialID", "Unrecognizable");
PETScWrappers::MPI::Vector w(MPI_COMM_WORLD, 20, 20);
test(v, w);
- // SOme output
+ // Some output
deallog << "Complex vectors: " << std::endl;
v.print(deallog.get_file_stream(), 0, false, true);
w.print(deallog.get_file_stream(), 0, false, true);