New: Added TrilinosWrappers::SolveDirect::initialize and
TrilinosWrappers::SolverDirect::solve to solve distributed linear systems
with multiple right hand sides without needing to refactorize the matrix
- everytime.
+ every time.
<br>
(Michael Harmon, 2016/06/30)
</li>
position_idx < parameters.nb_probe_points;
++position_idx)
{
- // Because of the way the operator + and - are overloaded. To substract
+ // Because of the way the operator + and - are overloaded to subtract
// two points, the following has to be done:
// `Point_b<dim> + (-Point_a<dim>)`
const Point<dim> p =
//@}
/**
- * @name Trignometric functions
+ * @name Trigonometric functions
*/
//@{
//@}
/**
- * @name Hyperbolic trignometric functions
+ * @name Hyperbolic trigonometric functions
*/
//@{
* discontinuous Galerkin methods).
*
* If you need to retrieve values or gradients of finite element solution
- * vectors, on the cell, face, or subface that has just beeing initialized
+ * vectors, on the cell, face, or subface that has just been initialized
* with one of the functions in @ref CurrentCellMethods, you can use the
* methods in @ref CurrentCellEvaluation.
*
/**
* The constructor takes an OpenCASCADE TopoDS_Face @p face and an optional
* @p tolerance. This class uses the interval OpenCASCADE variables @var u,
- * @var v to descrive the manifold.
+ * @var v to describe the manifold.
*/
NURBSPatchManifold(const TopoDS_Face &face, const double tolerance = 1e-7);
max_step(param.get_double("Max step"));
final(param.get_double("Final"));
tolerance(param.get_double("Tolerance"));
- print_step = param.get_double("Print step");
- const std::string strat = param.get("Strategy");
- if (strat == std::string("uniform"))
+ print_step = param.get_double("Print step");
+ const std::string strategy = param.get("Strategy");
+ if (strategy == std::string("uniform"))
strategy_val = uniform;
- else if (strat == std::string("doubling"))
+ else if (strategy == std::string("doubling"))
strategy_val = doubling;
}
// Here we substitute in symbol_values_resolved instead of
// symbol_values, in order to break any cyclic dependencies.
// The earlier entries in the dictionary are in this way
- // guarenteed to be resolved before any subsequent entries,
+ // guaranteed to be resolved before any subsequent entries,
// thereby breaking the dependency loop.
out = out.substitute(symbol_values_resolved);
}
//
// To deal with the case that at least one of the processors does not own
// any cell at all, we will exchange the information about the data sizes
- // among them later. The code inbetween is still well-defined, since the
+ // among them later. The code in between is still well-defined, since the
// following loops will be skipped.
std::vector<unsigned int> local_sizes_fixed(
1 + n_callbacks_fixed + (variable_size_data_stored ? 1 : 0));
template <int dim, int spacedim>
void
ParticleHandler<dim, spacedim>::initialize(
- const parallel::distributed::Triangulation<dim, spacedim> &tria,
- const Mapping<dim, spacedim> & mapp,
- const unsigned int n_properties)
+ const parallel::distributed::Triangulation<dim, spacedim>
+ & new_triangulation,
+ const Mapping<dim, spacedim> &new_mapping,
+ const unsigned int n_properties)
{
- triangulation = &tria;
- mapping = &mapp;
+ triangulation = &new_triangulation;
+ mapping = &new_mapping;
// Create the memory pool that will store all particle properties
property_pool = std_cxx14::make_unique<PropertyPool>(n_properties);
* function for which the enrichment function is to be estimated.
*
* The center is 0 since the function is evaluated with respect to
- * relative position from focal point anyway.
+ * the relative position from the focal point anyway.
*
- * For hexahedral cells, dimension can extend upto sqrt(3) < 2 times!
- * So take a factor of 4 as size of the problem. This ensures that
+ * For hexahedral cells, the dimension can extend up to sqrt(3) < 2 times!
+ * So take a factor of 4 as size of the problem. This ensures that the
* enrichment function can be evaluated at all points in the enrichment
- * domain
+ * domain.
*/
double center = 0;
double sigma = prm.sigmas[i];
// a problem uncovered by Baerbel Janssen in that
// DoFTools::make_flux_sparsity_pattern aborted in 1d with adaptively refined
// meshes and hp DoFHandlers. this actually uncovered all sorts of other
-// problems that led to a long sequence of assertions triggered everytime one
+// problems that led to a long sequence of assertions triggered every time one
// of them was fixed. this test cumulatively makes sure everything is ok
// while there, also test the same code in 2d (3d appears to take too long)