// the function internally has four branches, with different code used
// for the cases with/without coefficient and scalar/vector-valued
// finite element. we test these four cases through the _01, _02, _03,
-// and _04 tests. the version with a coefficient is tested in the
-// _0[1234]a tests, and versions without computing a right hand side
-// vectors with and without coefficient in the _0[1234][bc] tests
+// and _04 tests. the version without creating a right hand side
+// vector is tested in the _0[1234]a tests
SparseMatrix<double> matrix;
matrix.reinit (sparsity);
- Functions::ExpFunction<dim> coefficient;
+ Functions::ExpFunction<dim> rhs_function;
Vector<double> rhs (dof.n_dofs());
MatrixTools::
create_laplace_matrix (mapping, dof,
quadrature, matrix,
- coefficient, rhs);
+ rhs_function, rhs);
// since we only generate
// output with two digits after
// the function internally has four branches, with different code used
// for the cases with/without coefficient and scalar/vector-valued
// finite element. we test these four cases through the _01, _02, _03,
-// and _04 tests. the version with a coefficient is tested in the
-// _0[1234]a tests, and versions without computing a right hand side
-// vectors with and without coefficient in the _0[1234][bc] tests
+// and _04 tests. the version without creating a right hand side
+// vector is tested in the _0[1234]a tests
SparseMatrix<double> matrix;
matrix.reinit (sparsity);
- Functions::ExpFunction<dim> coefficient;
+ Functions::ExpFunction<dim> rhs_function;
Vector<double> rhs (dof.n_dofs());
MatrixTools::
create_laplace_matrix (mapping, dof,
quadrature, matrix,
- coefficient, rhs);
+ rhs_function, rhs);
// since we only generate
// output with two digits after
// the function internally has four branches, with different code used
// for the cases with/without coefficient and scalar/vector-valued
// finite element. we test these four cases through the _01, _02, _03,
-// and _04 tests. the version with a coefficient is tested in the
-// _0[1234]a tests, and versions without computing a right hand side
-// vectors with and without coefficient in the _0[1234][bc] tests
+// and _04 tests. the version without creating a right hand side
+// vector is tested in the _0[1234]a tests
SparseMatrix<double> matrix;
matrix.reinit (sparsity);
- Functions::ExpFunction<dim> coefficient;
+ Functions::ExpFunction<dim> rhs_function;
Vector<double> rhs (dof.n_dofs());
MatrixTools::
create_laplace_matrix (mapping, dof,
quadrature, matrix,
- coefficient, rhs,
- &coefficient);
+ rhs_function, rhs,
+ &rhs_function);
// since we only generate
// output with two digits after
// the function internally has four branches, with different code used
// for the cases with/without coefficient and scalar/vector-valued
// finite element. we test these four cases through the _01, _02, _03,
-// and _04 tests. the version with a coefficient is tested in the
-// _0[1234]a tests, and versions without computing a right hand side
-// vectors with and without coefficient in the _0[1234][bc] tests
+// and _04 tests. the version without creating a right hand side
+// vector is tested in the _0[1234]a tests
SparseMatrix<double> matrix;
matrix.reinit (sparsity);
- Functions::ExpFunction<dim> coefficient;
+ Functions::ExpFunction<dim> rhs_function;
Vector<double> rhs (dof.n_dofs());
MatrixTools::
create_laplace_matrix (mapping, dof,
quadrature, matrix,
- coefficient, rhs,
- &coefficient);
+ rhs_function, rhs,
+ &rhs_function);
// since we only generate
// output with two digits after