const unsigned int point_index) const
{
return quadrature_point(point_index);
- ;
}
{
const Number2 val0 = matrix[n_cols * n_columns + ind];
res0 += val0 * (x[ind] + x[mm - 1 - ind]);
- ;
}
if (mm % 2)
res0 += x[mid];
ad_helper.extract_gradient_component(Dpsi, s_dof);
std::cout << "extracted Dpsi (t): " << dpsi_dt << "\n"
<< "extracted Dpsi (s): " << dpsi_ds << "\n";
- ;
// Verify the result
using func = FunctionsTestTensorScalarCoupled<dim, ScalarNumberType>;
vmult(dealii::PETScWrappers::MPI::Vector &dst,
const dealii::PETScWrappers::MPI::Vector &src) const
{
- ;
solver.solve(matrix, dst, src, preconditioner);
}
vmult(dealii::PETScWrappers::MPI::Vector &dst,
const dealii::PETScWrappers::MPI::Vector &src) const
{
- ;
solver.solve(matrix, dst, src, preconditioner);
}
if (v[0][0] == 0)
{
v[0][0] = 3.52549435;
- ;
v[1][0] = 1.76274717;
v[2][0] = 1.07267252;
v[3][0] = 0.727635187;
{
typename DoFHandler<dim>::cell_iterator neighbor =
cell->neighbor(face_no);
- ;
if (face->has_children())
{
VectorTools::get_position_vector(map_dh, euler_vec);
MappingFEField<dim, spacedim> mapping(map_dh, euler_vec);
- ;
- DataOut<dim, spacedim> data_out_scal;
+ DataOut<dim, spacedim> data_out_scal;
data_out_scal.attach_dof_handler(dof_handler);
data_out_scal.add_data_vector(scal_sol,
SparsityPattern bl(tr.n_cells(level - 1),
dof.n_dofs(level),
(1 << dim) * fe.dofs_per_cell);
- ;
DoFTools::make_child_patches(bl, dof, level, false, false);
bl.compress();
print_patches(bl);
SparsityPattern bl(tr.n_cells(level - 1),
dof.n_dofs(level),
(1 << dim) * fe.dofs_per_cell);
- ;
DoFTools::make_child_patches(bl, dof, level, true, false);
bl.compress();
print_patches(bl);
SparsityPattern bl(tr.n_cells(level - 1),
dof.n_dofs(level),
(1 << dim) * fe.dofs_per_cell);
- ;
DoFTools::make_child_patches(bl, dof, level, true, true);
bl.compress();
print_patches(bl);
for (unsigned int i = 0; i < w.size(); ++i)
deallog << ' ' << w[i];
deallog << " ]" << std::endl << '[';
- ;
for (unsigned int i = 0; i < v.size(); ++i)
deallog << ' ' << v[i];
deallog << " ]" << std::endl;
test();
deallog << "OK" << std::endl;
- ;
return 0;
}
test();
deallog << "OK" << std::endl;
- ;
return 0;
}
{
typename DoFHandler<dim>::cell_iterator neighbor =
cell->neighbor(face_no);
- ;
if (face->has_children())
{
for (unsigned int i = 0; i < 3; ++i)
{
u.block(i)[0] = 0;
- ;
v.block(i)[0] = 0;
}
u.block(j)[0] = 1;
v.block(i)[0] = 0;
}
u.block(j)[0] = 1;
- ;
inverse_op_a.vmult(v, u);
for (unsigned int i = 0; i < 3; ++i)
{
u.block(i)[0] = 0;
- ;
v.block(i)[0] = 0;
}
u.block(j)[0] = 1;
- ;
identity.vmult(v, u);
for (unsigned int i = 0; i < 3; ++i)
{
u.block(i)[0] = 0;
- ;
v.block(i)[0] = 0;
}
u.block(j)[0] = 1;
v.block(i)[0] = 0;
}
u.block(j)[0] = 1;
- ;
inverse_op_a.vmult(v, u);
for (unsigned int i = 0; i < 3; ++i)
{
u.block(i)[0] = 0;
- ;
v.block(i)[0] = 0;
}
u.block(j)[0] = 1;
- ;
identity.vmult(v, u);
test()
{
const unsigned int n = 2;
- ;
- Vector<number> rhs(n), sol(n);
+ Vector<number> rhs(n), sol(n);
rhs = 0.;
LAPACKFullMatrix<number> matrix(n, n);
Point<2> Q = manifold.get_intermediate_point(P1, P2, .5);
deallog << "=================================" << std::endl;
- ;
deallog << manifold.get_intermediate_point(P1, P2, .125) << std::endl;
deallog << manifold.get_intermediate_point(P1, P2, .25) << std::endl;
deallog << manifold.get_intermediate_point(P1, P2, .375) << std::endl;
Point<2> Q = manifold.get_intermediate_point(P1, P2, .5);
deallog << "=================================" << std::endl;
- ;
deallog << manifold.get_intermediate_point(P1, P2, .125) << std::endl;
deallog << manifold.get_intermediate_point(P1, P2, .25) << std::endl;
deallog << manifold.get_intermediate_point(P1, P2, .375) << std::endl;
Point<3> Q = manifold.get_intermediate_point(P1, P2, .5);
deallog << "=================================" << std::endl;
- ;
deallog << manifold.get_intermediate_point(P1, P2, .125) << std::endl;
deallog << manifold.get_intermediate_point(P1, P2, .25) << std::endl;
deallog << manifold.get_intermediate_point(P1, P2, .375) << std::endl;
const unsigned int num_points = 20;
deallog << "=================================" << std::endl;
- ;
for (unsigned int i = 0; i < num_points; ++i)
deallog << manifold.get_intermediate_point(P1,
P2,
Point<3> R = manifold.get_intermediate_point(P5, P4, 2.0 / 3.0);
deallog << "=================================" << std::endl;
- ;
deallog << Q << std::endl;
deallog << S << std::endl;
deallog << T << std::endl;
const unsigned int solid_cells_x = 20;
const unsigned int solid_cells_y = 1;
const unsigned int v_space_cells = 5;
- ;
- const double cell_size_x = 0.1;
- const double cell_size_y = 0.1;
- const double length = solid_cells_x * cell_size_x,
- height = static_cast<double>(h_cells * cell_size_y),
- h_distance = static_cast<double>(cell_size_x * inflow_cells),
- v_distance = static_cast<double>(cell_size_y * v_space_cells),
- solid_top = static_cast<double>(v_distance +
+ const double cell_size_x = 0.1;
+ const double cell_size_y = 0.1;
+ const double length = solid_cells_x * cell_size_x,
+ height = static_cast<double>(h_cells * cell_size_y),
+ h_distance = static_cast<double>(cell_size_x * inflow_cells),
+ v_distance = static_cast<double>(cell_size_y * v_space_cells),
+ solid_top = static_cast<double>(v_distance +
solid_cells_y * cell_size_y),
total_length =
(inflow_cells + solid_cells_x + outflow_cells) * cell_size_x;
{
typename DoFHandler<dim>::cell_iterator neighbor =
cell->neighbor(face_no);
- ;
if (face->has_children())
{
deallog << "symbolic a/b: " << symb_a_division_b << std::endl;
const SD_number_t a_division_symb_b = a / symb_b;
- ;
deallog << "a/symbolic b: " << a_division_symb_b << std::endl;
const SD_number_t substitute_symb_a_division_b =
deallog << "symbolic a*b: " << symb_a_product_b << std::endl;
const SD_number_t a_product_symb_b = a * symb_b;
- ;
deallog << "a*symbolic b: " << a_product_symb_b << std::endl;
const SD_number_t substitute_symb_a_product_b =
Utilities::MPI::MPI_InitFinalize mpi_initialization(
argc, argv, testing_max_num_threads());
initlog();
- ;
test();
}