AssertThrow(false,
ExcMessage(
"The derivative values for taped ADOL-C numbers must be"
- "computed through the ::gradient function."));
+ " computed through the ::gradient function."));
return 0.0;
}
};
{
AssertThrow(false,
ExcMessage(
- "FESeries::process_coefficients() can not be used with"
+ "FESeries::process_coefficients() can not be used with "
"complex-valued coefficients and VectorTools::mean norm."));
return std::abs(value);
}
int,
<< "You are trying to access the matrix entry with index <"
<< arg1 << ',' << arg2
- << ">, but this entry does not exist in the sparsity pattern"
+ << ">, but this entry does not exist in the sparsity pattern "
"of this matrix."
"\n\n"
"The most common cause for this problem is that you used "
AssertThrowMPI(ierr);
Assert(flag == 1,
ExcMessage(
- "MPI found unfinished update_ghost_values() requests"
- "when calling swap, which is not allowed"));
+ "MPI found unfinished update_ghost_values() requests "
+ "when calling swap, which is not allowed."));
}
if (compress_requests.size() > 0)
{
AssertThrowMPI(ierr);
Assert(flag == 1,
ExcMessage("MPI found unfinished compress() requests "
- "when calling swap, which is not allowed"));
+ "when calling swap, which is not allowed."));
}
}
# endif
#ifndef DEAL_II_MSVC
static_assert(
std::is_same<typename VectorType::value_type, value_type>::value,
- "The vector type must be based on the same value type as this"
+ "The vector type must be based on the same value type as this "
"operator");
#endif
#ifndef DEAL_II_MSVC
static_assert(
std::is_same<typename VectorType::value_type, value_type>::value,
- "The vector type must be based on the same value type as this"
+ "The vector type must be based on the same value type as this "
"operator");
#endif
for (dealii::IndexSet::size_type index : ghost_indices_data)
{
Assert(larger_ghost_index_set.is_element(index),
- ExcMessage("The given larger ghost index set must contain"
+ ExcMessage("The given larger ghost index set must contain "
"all indices in the actual index set."));
Assert(
larger_ghost_index_set.index_within_set(index) <
Assert(this->is_recording() == true,
ExcMessage(
"Cannot change the value of an independent variable "
- "of the tapeless variety while this class is not set"
+ "of the tapeless variety while this class is not set "
"in recording operations."));
}
if (ADNumberTraits<ad_type>::is_taped == true)
{
Assert(AD::ADNumberTraits<ad_type>::n_supported_derivative_levels >= 2,
ExcMessage(
- "Cannot computed function Hessian: AD number type does"
+ "Cannot computed function Hessian: AD number type does "
"not support the calculation of second order derivatives."));
if ((ADNumberTraits<ad_type>::is_taped == true &&
{
Assert(AD::ADNumberTraits<ad_type>::n_supported_derivative_levels >= 2,
ExcMessage(
- "Cannot computed function Hessian: AD number type does"
+ "Cannot computed function Hessian: AD number type does "
"not support the calculation of second order derivatives."));
if ((ADNumberTraits<ad_type>::is_taped == true &&
Assert(
max_active_cells == this->n_active_cells(),
ExcMessage(
- "A parallel::shared::Triangulation needs to be refined in the same"
+ "A parallel::shared::Triangulation needs to be refined in the same "
"way on all processors, but the participating processors don't "
"agree on the number of active cells."));
# endif
dof_handler->get_fe(fe_index).dofs_per_cell ==
it_dofvalues->size(),
ExcMessage(
- "The transferred data was packed with a different number of dofs than the"
+ "The transferred data was packed with a different number of dofs than the "
"currently registered FE object assigned to the DoFHandler has."));
// distribute data for each registered vector on mesh
Assert(
cell->get_fe().dofs_per_cell == it_dofvalues->size(),
ExcMessage(
- "The transferred data was packed with a different number of dofs than the"
+ "The transferred data was packed with a different number of dofs than the "
"currently registered FE object assigned to the DoFHandler has."));
// distribute data for each registered vector on mesh
DoFHandlerType::space_dimension> *>(
&dof_handler.get_triangulation()) == nullptr),
ExcMessage(
- "This function can not be used with distributed triangulations."
+ "This function can not be used with distributed triangulations. "
"See the documentation for more information."));
IndexSet indices;
const parallel::distributed::Triangulation<dim, spacedim> *>(
&dof_handler.get_triangulation()) == nullptr),
ExcMessage(
- "This function can not be used with distributed triangulations."
+ "This function can not be used with distributed triangulations. "
"See the documentation for more information."));
// Let the internal function do all the work, just make sure that it
const parallel::distributed::Triangulation<dim, spacedim> *>(
&dof_handler.get_triangulation()) == nullptr),
ExcMessage(
- "This function can not be used with distributed triangulations."
+ "This function can not be used with distributed triangulations. "
"See the documentation for more information."));
// Let the internal function do all the work, just make sure that it
ExcIndexRange(direction, 0, space_dim));
Assert(b_id1 != b_id2,
- ExcMessage("The boundary indicators b_id1 and b_id2 must be"
+ ExcMessage("The boundary indicators b_id1 and b_id2 must be "
"different to denote different boundaries."));
std::vector<
(void)x_q;
(void)indices;
AssertThrow(false,
- ExcMessage("deal.II has to be configured with GSL"
+ ExcMessage("deal.II has to be configured with GSL "
"in order to use Legendre transformation."));
return 0;
#endif
param.declare_entry("Size by",
"width",
Patterns::Selection("width|height"),
- "Depending on this parameter, either the"
+ "Depending on this parameter, either the "
"width or height "
"of the eps is scaled to \"Size\"");
param.declare_entry("Size",
param.declare_entry("Level number",
"false",
Patterns::Bool(),
- "(2D only) if \"Cell number\" is true, write"
+ "(2D only) if \"Cell number\" is true, write "
"numbers in the form level.number");
param.declare_entry("Vertex number",
"false",
contains_artificial_cells<MeshType>(ghost_cell_layer_within_distance) ==
false,
ExcMessage(
- "Ghost cells within layer_thickness contains artificial cells."
+ "Ghost cells within layer_thickness contains artificial cells. "
"The function compute_ghost_cell_layer_within_distance "
"is probably called while using parallel::distributed::Triangulation. "
"In such case please refer to the description of this function."));
"not be used to copy a non-empty sparsity pattern."));
Assert(rows == 0 && cols == 0,
- ExcMessage("This operator can only be called if the current object is"
+ ExcMessage("This operator can only be called if the current object is "
"empty."));
return *this;
// make sure the preconditioner has an associated matrix set
const Mat B = preconditioner;
AssertThrow(B != nullptr,
- ExcMessage("PETSc preconditioner should have an"
+ ExcMessage("PETSc preconditioner should have an "
"associated matrix set to be used in solver."));
// setting the preconditioner overwrites the used matrices.
Assert((false),
ExcMessage(
"Folding transformation has been removed in SLEPc 3.5.0 and newer."
- "You cannot use this transformation anymore."));
+ " You cannot use this transformation anymore."));
# endif
}
{
vmult = [](Range &, const Domain &) {
Assert(false,
- ExcMessage("Uninitialized TrilinosPayload::vmult called"
+ ExcMessage("Uninitialized TrilinosPayload::vmult called "
"(Default constructor)"));
};
Tvmult = [](Domain &, const Range &) {
Assert(false,
- ExcMessage("Uninitialized TrilinosPayload::Tvmult called"
+ ExcMessage("Uninitialized TrilinosPayload::Tvmult called "
"(Default constructor)"));
};
inv_vmult = [](Domain &, const Range &) {
Assert(false,
- ExcMessage("Uninitialized TrilinosPayload::inv_vmult called"
+ ExcMessage("Uninitialized TrilinosPayload::inv_vmult called "
"(Default constructor)"));
};
inv_Tvmult = [](Range &, const Domain &) {
Assert(false,
- ExcMessage("Uninitialized TrilinosPayload::inv_Tvmult called"
+ ExcMessage("Uninitialized TrilinosPayload::inv_Tvmult called "
"(Default constructor)"));
};
}
inv_vmult = [](Domain &, const Range &) {
Assert(false,
- ExcMessage("Uninitialized TrilinosPayload::inv_vmult called"
+ ExcMessage("Uninitialized TrilinosPayload::inv_vmult called "
"(Matrix constructor with matrix exemplar)"));
};
inv_Tvmult = [](Range &, const Domain &) {
Assert(false,
- ExcMessage("Uninitialized TrilinosPayload::inv_Tvmult called"
+ ExcMessage("Uninitialized TrilinosPayload::inv_Tvmult called "
"(Matrix constructor with matrix exemplar)"));
};
}