Home
last modified time | relevance | path

Searched refs:n_dofs (Results 1 – 25 of 292) sorted by relevance

12345678910>>...12

/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/include/deal.II/integrators/
H A Dlaplace.h100 Assert(result.size() == n_dofs,
129 Assert(result.size() == n_dofs,
165 Assert(M.m() == n_dofs, ExcDimensionMismatch(M.m(), n_dofs));
166 Assert(M.n() == n_dofs, ExcDimensionMismatch(M.n(), n_dofs));
205 Assert(M.m() == n_dofs, ExcDimensionMismatch(M.m(), n_dofs));
206 Assert(M.n() == n_dofs, ExcDimensionMismatch(M.n(), n_dofs));
370 AssertDimension(M11.n(), n_dofs);
371 AssertDimension(M11.m(), n_dofs);
372 AssertDimension(M12.n(), n_dofs);
373 AssertDimension(M12.m(), n_dofs);
[all …]
H A Dmaxwell.h170 AssertDimension(M.m(), n_dofs);
171 AssertDimension(M.n(), n_dofs);
228 AssertDimension(M.n(), n_dofs);
274 AssertDimension(M.m(), n_dofs);
275 AssertDimension(M.n(), n_dofs);
335 AssertDimension(M.m(), n_dofs);
336 AssertDimension(M.n(), n_dofs);
399 AssertDimension(M11.m(), n_dofs);
400 AssertDimension(M11.n(), n_dofs);
401 AssertDimension(M12.m(), n_dofs);
[all …]
H A Dgrad_div.h59 AssertDimension(M.m(), n_dofs);
60 AssertDimension(M.n(), n_dofs);
130 AssertDimension(M.m(), n_dofs);
131 AssertDimension(M.n(), n_dofs);
233 AssertDimension(M11.n(), n_dofs);
234 AssertDimension(M11.m(), n_dofs);
235 AssertDimension(M12.n(), n_dofs);
236 AssertDimension(M12.m(), n_dofs);
237 AssertDimension(M21.n(), n_dofs);
238 AssertDimension(M21.m(), n_dofs);
[all …]
H A Ddivergence.h64 AssertDimension(M.n(), n_dofs);
168 AssertDimension(M.n(), n_dofs);
270 AssertDimension(M.n(), n_dofs);
376 AssertDimension(M11.n(), n_dofs);
378 AssertDimension(M12.n(), n_dofs);
380 AssertDimension(M21.n(), n_dofs);
382 AssertDimension(M22.n(), n_dofs);
429 AssertDimension(M11.m(), n_dofs);
430 AssertDimension(M11.n(), n_dofs);
431 AssertDimension(M12.m(), n_dofs);
[all …]
H A Dl2.h62 const unsigned int n_dofs = fe.dofs_per_cell; variable
68 for (unsigned int i = 0; i < n_dofs; ++i)
113 const unsigned int n_dofs = fe.dofs_per_cell; in weighted_mass_matrix() local
115 AssertDimension(M.m(), n_dofs); in weighted_mass_matrix()
116 AssertDimension(M.n(), n_dofs); in weighted_mass_matrix()
122 for (unsigned int i = 0; i < n_dofs; ++i) in weighted_mass_matrix()
165 const unsigned int n_dofs = fe.dofs_per_cell; variable
166 AssertDimension(result.size(), n_dofs);
171 for (unsigned int i = 0; i < n_dofs; ++i)
198 AssertDimension(result.size(), n_dofs);
[all …]
H A Delasticity.h58 AssertDimension(M.m(), n_dofs);
59 AssertDimension(M.n(), n_dofs);
94 Assert(result.size() == n_dofs,
131 AssertDimension(M.m(), n_dofs);
132 AssertDimension(M.n(), n_dofs);
186 AssertDimension(M.m(), n_dofs);
187 AssertDimension(M.n(), n_dofs);
446 AssertDimension(M11.m(), n_dofs);
447 AssertDimension(M11.n(), n_dofs);
448 AssertDimension(M12.m(), n_dofs);
[all …]
H A Dadvection.h97 AssertDimension(M.n(), n_dofs);
105 for (unsigned j = 0; j < n_dofs; ++j)
140 Assert(result.size() == n_dofs,
153 for (unsigned i = 0; i < n_dofs; ++i)
185 Assert(result.size() == n_dofs,
198 for (unsigned i = 0; i < n_dofs; ++i)
225 Assert(result.size() == n_dofs,
238 for (unsigned i = 0; i < n_dofs; ++i)
267 Assert(result.size() == n_dofs,
319 AssertDimension(M.m(), n_dofs);
[all …]
/dports/math/libmesh/libmesh-1.6.2/src/solvers/
H A Dsecond_order_unsteady_solver.C48 _old_local_solution_rate->init (_system.n_dofs(), _system.n_local_dofs(), in init_data()
52 _old_local_solution_accel->init (_system.n_dofs(), _system.n_local_dofs(), in init_data()
56 _old_local_solution_rate->init (_system.n_dofs(), false, SERIAL); in init_data()
57 _old_local_solution_accel->init (_system.n_dofs(), false, SERIAL); in init_data()
66 _old_local_solution_rate->init (_system.n_dofs(), _system.n_local_dofs(), in reinit()
70 _old_local_solution_accel->init (_system.n_dofs(), _system.n_local_dofs(), in reinit()
74 _old_local_solution_rate->init (_system.n_dofs(), false, SERIAL); in reinit()
75 _old_local_solution_accel->init (_system.n_dofs(), false, SERIAL); in reinit()
111 libmesh_assert_less (global_dof_number, _system.get_dof_map().n_dofs()); in old_solution_rate()
120 libmesh_assert_less (global_dof_number, _system.get_dof_map().n_dofs()); in old_solution_accel()
H A Deuler2_solver.C108 unsigned int n_dofs = context.get_elem_solution().size(); in _general_residual() local
111 DenseVector<Number> old_elem_solution(n_dofs); in _general_residual()
112 for (unsigned int i=0; i != n_dofs; ++i) in _general_residual()
136 DenseMatrix<Number> old_elem_jacobian(n_dofs, n_dofs); in _general_residual()
137 DenseVector<Number> old_elem_residual(n_dofs); in _general_residual()
188 DenseMatrix<Number> elem_jacobian_newterm(n_dofs, n_dofs); in _general_residual()
189 DenseVector<Number> elem_residual_newterm(n_dofs); in _general_residual()
H A Dnewmark_solver.C212 unsigned int n_dofs = context.get_elem_solution().size(); in _general_residual() local
216 DenseMatrix<Number> old_elem_jacobian(n_dofs, n_dofs); in _general_residual()
219 DenseVector<Number> old_elem_solution_rate(n_dofs); in _general_residual()
220 for (unsigned int i=0; i != n_dofs; ++i) in _general_residual()
234 DenseVector<Number> old_elem_solution(n_dofs); in _general_residual()
235 for (unsigned int i=0; i != n_dofs; ++i) in _general_residual()
268 DenseVector<Number> old_elem_solution(n_dofs); in _general_residual()
269 for (unsigned int i=0; i != n_dofs; ++i) in _general_residual()
274 DenseVector<Number> old_elem_solution_accel(n_dofs); in _general_residual()
275 for (unsigned int i=0; i != n_dofs; ++i) in _general_residual()
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/source/dofs/
H A Ddof_renumbering.cc288 int n = dof_handler.n_dofs(); in compute_minimum_degree()
426 DynamicSparsityPattern dsp(dof_handler.n_dofs(), dof_handler.n_dofs()); in compute_Cuthill_McKee()
1450 const types::global_dof_index n_dofs = dof_handler.n_dofs(); in compute_sort_selected_dofs_back() local
1492 const unsigned int n_dofs = dof_handler.n_dofs(level); in compute_sort_selected_dofs_back() local
1739 const unsigned int n_dofs = dof.n_dofs(); in compute_downstream() local
1741 support_point_list(n_dofs); in compute_downstream()
1847 const unsigned int n_dofs = dof.n_dofs(level); in compute_downstream() local
1849 support_point_list(n_dofs); in compute_downstream()
2069 const types::global_dof_index n_dofs = dof_handler.n_dofs(); in compute_random() local
2103 const types::global_dof_index n_dofs = dof_handler.n_dofs(level); in compute_random() local
[all …]
H A Ddof_tools_sparsity.cc70 const types::global_dof_index n_dofs = dof.n_dofs(); in make_sparsity_pattern() local
71 (void)n_dofs; in make_sparsity_pattern()
132 const types::global_dof_index n_dofs = dof.n_dofs(); in make_sparsity_pattern() local
133 (void)n_dofs; in make_sparsity_pattern()
378 const types::global_dof_index n_dofs = dof.n_dofs(); in make_boundary_sparsity_pattern() local
379 (void)n_dofs; in make_boundary_sparsity_pattern()
473 const types::global_dof_index n_dofs = dof.n_dofs(); in make_boundary_sparsity_pattern() local
474 (void)n_dofs; in make_boundary_sparsity_pattern()
536 const types::global_dof_index n_dofs = dof.n_dofs(); in make_flux_sparsity_pattern() local
719 Table<2, Coupling> dof_couplings(n_dofs, n_dofs); in dof_couplings_from_component_couplings()
[all …]
/dports/science/py-OpenFermion/OpenFermion-1.3.0/src/openfermion/utils/
H A Dlattice_test.py35 n_dofs=n_dofs,
55 for indices in itertools.product(site_indices, range(n_dofs),
72 n_dofs * (n_dofs + 1) / 2
73 assert len(tuple(lattice.dof_pairs_iter(True))) == n_dofs * (n_dofs - 1) / 2
84 assert lattice.n_dofs == 1
90 def test_hubbard_square_lattice_dof_validation(n_dofs): argument
91 lattice = HubbardSquareLattice(3, 3, n_dofs=n_dofs)
92 for a in range(n_dofs):
94 for ab in itertools.combinations(range(n_dofs), 2):
96 for abc in itertools.combinations(range(n_dofs), 3):
[all …]
H A Dlattice.py55 def n_dofs(self): member in HubbardLattice
90 return self.n_dofs * self.n_spin_values
123 return range(self.n_dofs)
127 for a in range(self.n_dofs)
128 for b in range(a + exclude_same, self.n_dofs))
155 if not (0 <= dof < self.n_dofs):
157 dof, self.n_dofs))
180 n_dofs=1, argument
197 self._n_dofs = n_dofs
202 def n_dofs(self): member in HubbardSquareLattice
[all …]
/dports/math/libmesh/libmesh-1.6.2/examples/introduction/introduction_ex3/
H A Dintroduction_ex3.C290 const unsigned int n_dofs = in assemble_poisson() local
301 libmesh_assert_equal_to (n_dofs, phi.size()); in assemble_poisson()
312 Ke.resize (n_dofs, n_dofs); in assemble_poisson()
314 Fe.resize (n_dofs); in assemble_poisson()
324 for (unsigned int i=0; i != n_dofs; i++) in assemble_poisson()
325 for (unsigned int j=0; j != n_dofs; j++) in assemble_poisson()
360 for (unsigned int i=0; i != n_dofs; i++) in assemble_poisson()
423 libmesh_assert_equal_to (n_dofs, phi_face.size()); in assemble_poisson()
441 for (unsigned int i=0; i != n_dofs; i++) in assemble_poisson()
442 for (unsigned int j=0; j != n_dofs; j++) in assemble_poisson()
[all …]
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/tests/quick_tests/
H A Dumfpack.cc65 deallog << "Number of dofs = " << dof_handler.n_dofs() << std::endl; in test()
68 sparsity_pattern.reinit(dof_handler.n_dofs(), in test()
69 dof_handler.n_dofs(), in test()
85 Vector<double> solution(dof_handler.n_dofs()); in test()
86 Vector<double> x(dof_handler.n_dofs()); in test()
87 Vector<double> b(dof_handler.n_dofs()); in test()
89 for (unsigned int j = 0; j < dof_handler.n_dofs(); ++j) in test()
H A Dstep-petsc.cc90 A.reinit(dof_handler.n_dofs(), in setup_system()
91 dof_handler.n_dofs(), in setup_system()
93 b.reinit(MPI_COMM_WORLD, dof_handler.n_dofs(), dof_handler.n_dofs()); in setup_system()
94 x.reinit(MPI_COMM_WORLD, dof_handler.n_dofs(), dof_handler.n_dofs()); in setup_system()
98 output_table.add_value("dofs", dof_handler.n_dofs()); in setup_system()
/dports/math/libmesh/libmesh-1.6.2/examples/miscellaneous/miscellaneous_ex9/
H A Dmiscellaneous_ex9.C260 const unsigned int n_dofs = dof_indices.size(); in assemble_poisson() local
264 Ke.resize (n_dofs, n_dofs); in assemble_poisson()
265 Fe.resize (n_dofs); in assemble_poisson()
269 for (unsigned int i=0; i<n_dofs; i++) in assemble_poisson()
270 for (unsigned int j=0; j<n_dofs; j++) in assemble_poisson()
316 Kne.resize (n_neighbor_dofs, n_dofs); in assemble_poisson()
317 Ken.resize (n_dofs, n_neighbor_dofs); in assemble_poisson()
318 Kee.resize (n_dofs, n_dofs); in assemble_poisson()
323 for (unsigned int i=0; i<n_dofs; i++) in assemble_poisson()
324 for (unsigned int j=0; j<n_dofs; j++) in assemble_poisson()
[all …]
/dports/math/libmesh/libmesh-1.6.2/examples/miscellaneous/miscellaneous_ex4/
H A Dmiscellaneous_ex4.C184 system.get_vector("v").init(system.n_dofs(), system.n_local_dofs()); in main()
185 system.get_vector("w").init(system.n_dofs(), system.n_local_dofs()); in main()
339 const unsigned int n_dofs = in assemble() local
342 Ke.resize (n_dofs, n_dofs); in assemble()
344 Fe.resize (n_dofs); in assemble()
345 Ve.resize (n_dofs); in assemble()
346 We.resize (n_dofs); in assemble()
357 for (unsigned int i=0; i<n_dofs; i++) in assemble()
362 for (unsigned int j=0; j<n_dofs; j++) in assemble()
401 for (unsigned int i=0; i<n_dofs; i++) in assemble()
[all …]
/dports/science/code_saturne/code_saturne-7.1.0/src/cdo/
H A Dcs_static_condensation.c101 const int n_dofs = csys->n_dofs; in cs_static_condensation_scalar_eq() local
102 const int n_xc = n_dofs - 1; in cs_static_condensation_scalar_eq()
104 const double *row_c = csys->mat->val + n_dofs*n_xc; in cs_static_condensation_scalar_eq()
117 for (int i = 0; i < n_xc; i++) axc[i] = csys->mat->val[n_dofs*i + n_xc]; in cs_static_condensation_scalar_eq()
120 csys->n_dofs = n_xc; in cs_static_condensation_scalar_eq()
125 double *old_i = csys->mat->val + n_dofs*i; /* Old "i" row */ in cs_static_condensation_scalar_eq()
210 const int n_dofs = bd->n_row_blocks; in cs_static_condensation_vector_eq() local
211 const int n_xc = n_dofs - 1; in cs_static_condensation_vector_eq()
240 csys->n_dofs = stride*n_xc; in cs_static_condensation_vector_eq()
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/examples/step-34/
H A Dstep-34.cc538 const unsigned int n_dofs = dof_handler.n_dofs(); in refine_and_resize() local
540 system_matrix.reinit(n_dofs, n_dofs); in refine_and_resize()
542 system_rhs.reinit(n_dofs); in refine_and_resize()
543 phi.reinit(n_dofs); in refine_and_resize()
544 alpha.reinit(n_dofs); in refine_and_resize()
614 for (unsigned int i = 0; i < dof_handler.n_dofs(); ++i) in assemble_system()
735 Vector<double> ones(dof_handler.n_dofs()); in assemble_system()
740 for (unsigned int i = 0; i < dof_handler.n_dofs(); ++i) in assemble_system()
786 const unsigned int n_dofs = dof_handler.n_dofs(); in compute_errors() local
795 convergence_table.add_value("dofs", n_dofs); in compute_errors()
[all …]
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/source/multigrid/
H A Dmg_tools.cc581 const types::global_dof_index n_dofs = dof.n_dofs(level); in make_sparsity_pattern() local
582 (void)n_dofs; in make_sparsity_pattern()
584 Assert(sparsity.n_rows() == n_dofs, in make_sparsity_pattern()
586 Assert(sparsity.n_cols() == n_dofs, in make_sparsity_pattern()
614 const types::global_dof_index n_dofs = dof.n_dofs(level); in make_flux_sparsity_pattern() local
615 (void)n_dofs; in make_flux_sparsity_pattern()
617 Assert(sparsity.n_rows() == n_dofs, in make_flux_sparsity_pattern()
761 const types::global_dof_index n_dofs = dof.n_dofs(level); in make_flux_sparsity_pattern() local
763 (void)n_dofs; in make_flux_sparsity_pattern()
1039 const types::global_dof_index n_dofs = dof.n_dofs(level); in make_interface_sparsity_pattern() local
[all …]
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/examples/step-60/
H A Dstep-60.cc638 embedded_configuration.reinit(embedded_configuration_dh->n_dofs()); in setup_grids_and_dofs()
704 std::vector<Point<spacedim>> support_points(embedded_dh->n_dofs()); in setup_grids_and_dofs()
853 DynamicSparsityPattern dsp(space_dh->n_dofs(), space_dh->n_dofs()); in setup_embedding_dofs()
857 solution.reinit(space_dh->n_dofs()); in setup_embedding_dofs()
858 rhs.reinit(space_dh->n_dofs()); in setup_embedding_dofs()
860 deallog << "Embedding dofs: " << space_dh->n_dofs() << std::endl; in setup_embedding_dofs()
873 lambda.reinit(embedded_dh->n_dofs()); in setup_embedded_dofs()
874 embedded_rhs.reinit(embedded_dh->n_dofs()); in setup_embedded_dofs()
875 embedded_value.reinit(embedded_dh->n_dofs()); in setup_embedded_dofs()
877 deallog << "Embedded dofs: " << embedded_dh->n_dofs() << std::endl; in setup_embedded_dofs()
[all …]
/dports/math/libmesh/libmesh-1.6.2/examples/eigenproblems/eigenproblems_ex2/
H A Deigenproblems_ex2.C301 const unsigned int n_dofs = in assemble_mass() local
303 Ke.resize (n_dofs, n_dofs); in assemble_mass()
304 Me.resize (n_dofs, n_dofs); in assemble_mass()
313 for (unsigned int i=0; i<n_dofs; i++) in assemble_mass()
314 for (unsigned int j=0; j<n_dofs; j++) in assemble_mass()
/dports/math/libmesh/libmesh-1.6.2/examples/adaptivity/adaptivity_ex1/
H A Dadaptivity_ex1.C263 const unsigned int n_dofs = in assemble_1D() local
265 libmesh_assert_equal_to (n_dofs, phi.size()); in assemble_1D()
271 Ke.resize(n_dofs, n_dofs); in assemble_1D()
272 Fe.resize(n_dofs); in assemble_1D()
280 for (unsigned int i=0; i != n_dofs; i++) in assemble_1D()
284 for (unsigned int j=0; j != n_dofs; j++) in assemble_1D()

12345678910>>...12