Home
last modified time | relevance | path

Searched refs:fes (Results 1 – 25 of 984) sorted by relevance

12345678910>>...40

/dports/math/mfem/mfem-4.3/fem/
H A Dnonlinearform.cpp105 fe = fes->GetFE(i); in GetGridFunctionEnergy()
177 fe = fes->GetFE(i); in Mult()
474 fes(0), BlockGrad(NULL) in BlockNonlinearForm()
499 f.Copy(fes); in SetSpaces()
517 Grads.SetSize(fes.Size(), fes.Size()); in SetSpaces()
520 cGrads.SetSize(fes.Size(), fes.Size()); in SetSpaces()
523 P.SetSize(fes.Size()); in SetSpaces()
524 cP.SetSize(fes.Size()); in SetSpaces()
551 fes(0), BlockGrad(NULL) in BlockNonlinearForm()
843 Array2D<DenseMatrix *> elmats(fes.Size(), fes.Size()); in ComputeGradientBlocked()
[all …]
H A Dgridfunc.cpp158 delete fes; in Destroy()
196 fes = f; in SetSpace()
204 fes = f; in MakeRef()
213 fes = f; in MakeRef()
314 if (!fes->GetNE()) in VectorDim()
329 return fes->GetVDim()*fes->GetMesh()->SpaceDimension(); in VectorDim()
1773 fes->GetFE(0)->Project(*src.fes->GetFE(0), in ProjectGridFunction()
1787 fes->GetFE(i)->Project(*src.fes->GetFE(i), in ProjectGridFunction()
2060 if (fes->Nonconforming() && fes->GetMesh()->Dimension() == 3) in AccumulateAndCountBdrValues()
2167 if (fes->Nonconforming() && fes->GetMesh()->Dimension() == 3) in AccumulateAndCountBdrTangentValues()
[all …]
H A Dlinearform.cpp25 fes = f; in LinearForm()
129 for (i = 0; i < fes -> GetNE(); i++) in Assemble()
137 fes -> GetElementVDofs (i, vdofs); in Assemble()
150 Mesh *mesh = fes->GetMesh(); in Assemble()
173 for (i = 0; i < fes -> GetNBE(); i++) in Assemble()
177 fes -> GetBdrElementVDofs (i, vdofs); in Assemble()
194 Mesh *mesh = fes->GetMesh(); in Assemble()
243 Mesh *mesh = fes->GetMesh(); in Assemble()
271 fes = f; in Update()
316 fes->GetElementVDofs(elem_id, vdofs); in AssembleDelta()
[all …]
H A Dbilininteg_transpose_ea.cpp24 bfi->AssembleEA(fes, ea_data_tmp, false); in AssembleEA()
25 const int ne = fes.GetNE(); in AssembleEA()
27 const int dofs = fes.GetFE(0)->GetDof(); in AssembleEA()
44 bfi->AssembleEA(fes, ea_data, false); in AssembleEA()
45 const int ne = fes.GetNE(); in AssembleEA()
47 const int dofs = fes.GetFE(0)->GetDof(); in AssembleEA()
70 const int nf = fes.GetNFbyType(FaceType::Interior); in AssembleEAInteriorFaces()
77 const int faceDofs = fes.GetTraceElement(0, in AssembleEAInteriorFaces()
104 const int faceDofs = fes.GetTraceElement(0, in AssembleEAInteriorFaces()
148 const int faceDofs = fes.GetTraceElement(0, in AssembleEABoundaryFaces()
[all …]
H A Dpnonlinearform.cpp162 for (int s1=0; s1<fes.Size(); ++s1) in SetParSpaces()
179 phBlockGrad.SetSize(fes.Size(), fes.Size()); in SetParSpaces()
181 for (int s1=0; s1<fes.Size(); ++s1) in SetParSpaces()
210 for (int s = 0; s < fes.Size(); ++s) in SetEssentialBC()
225 for (int s = 0; s < fes.Size(); ++s) in GetEnergy()
247 for (int s=0; s<fes.Size(); ++s) in Mult()
260 for (int s=0; s<fes.Size(); ++s) in Mult()
280 for (int s=0; s<fes.Size(); ++s) in GetLocalGradient()
305 for (int s1=0; s1<fes.Size(); ++s1) in SetGradientType()
323 for (int s1=0; s1<fes.Size(); ++s1) in GetGradient()
[all …]
H A Dtmop_tools.cpp72 if (fes) in ComputeAtNewPositionScalar()
74 fess = new FiniteElementSpace(fes->GetMesh(), fes->FEColl(), 1); in ComputeAtNewPositionScalar()
173 u(vel), u_coeff(&u), M(&fes), K(&fes), al(al) in SerialAdvectorCGOper()
335 FiniteElementSpace *f = fes; in SetInitialField()
365 const FiniteElementSpace *fes = NULL; in ComputeScalingFactor() local
372 fes = p_nlf->FESpace(); in ComputeScalingFactor()
381 fes = nlf->FESpace(); in ComputeScalingFactor()
386 Vector x_out_loc(fes->GetVSize(), in ComputeScalingFactor()
656 const int NE = fes.GetNE(), dim = fes.GetMesh()->Dimension(); in ComputeMinDet()
711 ParGridFunction metric(&fes); in vis_tmop_metric_p()
[all …]
H A Drestriction.cpp23 : fes(f), in ElementRestriction()
24 ne(fes.GetNE()), in ElementRestriction()
25 vdim(fes.GetVDim()), in ElementRestriction()
27 ndofs(fes.GetNDofs()), in ElementRestriction()
36 width = fes.GetVSize(); in ElementRestriction()
466 : ne(fes.GetNE()), in L2ElementRestriction()
467 vdim(fes.GetVDim()), in L2ElementRestriction()
666 : fes(fes), in H1FaceRestriction()
996 : fes(fes), in L2FaceRestriction()
998 ne(fes.GetNE()), in L2FaceRestriction()
[all …]
H A Dlinearform.hpp27 FiniteElementSpace *fes; member in mfem::LinearForm
78 { fes = f; extern_lfs = 0; UseDevice(true); } in LinearForm()
93 LinearForm() { fes = NULL; extern_lfs = 0; UseDevice(true); } in LinearForm()
101 { fes = f; extern_lfs = 0; } in LinearForm()
114 MFEM_DEPRECATED FiniteElementSpace *GetFES() { return fes; } in GetFES()
117 FiniteElementSpace *FESpace() { return fes; } in FESpace()
119 const FiniteElementSpace *FESpace() const { return fes; } in FESpace()
187 void Update() { SetSize(fes->GetVSize()); ResetDeltaLocations(); } in Update()
191 { fes = f; SetSize(f->GetVSize()); ResetDeltaLocations(); } in Update()
H A Dbilinearform.cpp69 fes = f; in BilinearForm()
87 fes = f; in BilinearForm()
201 MFEM_ASSERT(A.Height() == fes->GetVSize() && A.Width() == fes->GetVSize(), in UseSparsity()
338 fes->GetElementVDofs(i, vdofs); in AssembleElementMatrix()
394 Mesh *mesh = fes -> GetMesh(); in Assemble()
871 int num_dofs_per_el = fes->GetFE(0)->GetDof() * fes->GetVDim(); in ComputeElementMatrices()
912 if (fes->GetVSize() == height) in EliminateEssentialBC()
929 if (fes->GetVSize() == height) in EliminateEssentialBC()
946 if (fes->GetVSize() == height) in EliminateEssentialBCDiag()
1059 if (nfes && nfes != fes) in Update()
[all …]
/dports/math/mfem/mfem-4.3/miniapps/mtop/
H A Dparamnonlinearform.cpp155 statef.Copy(fes); in SetSpaces()
161 for (int i=0; i<fes.Size(); ++i) in SetSpaces()
187 Grads.SetSize(fes.Size(), fes.Size()); in SetSpaces()
190 cGrads.SetSize(fes.Size(), fes.Size()); in SetSpaces()
193 P.SetSize(fes.Size()); in SetSpaces()
194 cP.SetSize(fes.Size()); in SetSpaces()
195 ess_tdofs.SetSize(fes.Size()); in SetSpaces()
273 for (int i=0; i<fes.Size(); ++i) in GetEnergyBlocked()
459 for (int s=0; s<fes.Size(); ++s) in MultParamBlocked()
964 Array2D<DenseMatrix *> elmats(fes.Size(), fes.Size()); in ComputeGradientBlocked()
[all …]
H A Dpparamnonlinearform.cpp35 for (int s1=0; s1<fes.Size(); ++s1) in SetParSpaces()
37 for (int s2=0; s2<fes.Size(); ++s2) in SetParSpaces()
56 phBlockGrad.SetSize(fes.Size(), fes.Size()); in SetParSpaces()
58 for (int s1=0; s1<fes.Size(); ++s1) in SetParSpaces()
98 for (int s = 0; s < fes.Size(); ++s) in SetEssentialBC()
130 for (int s = 0; s < fes.Size(); ++s) in GetEnergy()
151 for (int s=0; s<fes.Size(); ++s) in Mult()
164 for (int s=0; s<fes.Size(); ++s) in Mult()
211 for (int s=0; s<fes.Size(); ++s) in GetLocalGradient()
330 for (int s=0; s<fes.Size(); ++s) in SetStateFields()
[all …]
/dports/math/mfem/mfem-4.3/fem/ceed/
H A Dutil.cpp45 if (std::get<0>(itb->first)==fes) in RemoveBasisAndRestriction()
119 mfem::Mesh *mesh = fes.GetMesh(); in InitNonTensorBasis()
142 mfem::Mesh *mesh = fes.GetMesh(); in InitNonTensorRestriction()
145 CeedInt compstride = fes.GetOrdering()==Ordering::byVDIM ? 1 : fes.GetNDofs(); in InitNonTensorRestriction()
174 compstride, (fes.GetVDim())*(fes.GetNDofs()), in InitNonTensorRestriction()
185 mfem::Mesh *mesh = fes.GetMesh(); in InitTensorBasis()
213 CeedInt compstride = fes.GetOrdering()==Ordering::byVDIM ? 1 : fes.GetNDofs(); in InitTensorRestriction()
241 compstride, (fes.GetVDim())*(fes.GetNDofs()), in InitTensorRestriction()
279 const int ncomp = fes.GetVDim(); in InitBasisAndRestriction()
288 if (UsesTensorBasis(fes)) in InitBasisAndRestriction()
[all …]
/dports/graphics/blender/blender-2.91.0/source/blender/freestyle/intern/python/Interface1D/FEdge/
H A DBPy_FEdgeSharp.cpp66 self->fes = new FEdgeSharp(); in FEdgeSharp_init()
69 self->fes = new FEdgeSharp(*(((BPy_FEdgeSharp *)obj1)->fes)); in FEdgeSharp_init()
87 self->py_fe.fe = self->fes; in FEdgeSharp_init()
112 Vec3r p(self->fes->normalA()); in FEdgeSharp_mathutils_get()
118 Vec3r p(self->fes->normalB()); in FEdgeSharp_mathutils_get()
135 self->fes->setNormalA(p); in FEdgeSharp_mathutils_set()
139 self->fes->setNormalB(p); in FEdgeSharp_mathutils_set()
172 self->fes->setNormalA(p); in FEdgeSharp_mathutils_set_index()
177 self->fes->setNormalB(p); in FEdgeSharp_mathutils_set_index()
223 self->fes->setNormalA(p); in FEdgeSharp_normal_right_set()
[all …]
H A DBPy_FEdgeSmooth.cpp64 self->fes = new FEdgeSmooth(); in FEdgeSmooth_init()
67 self->fes = new FEdgeSmooth(*(((BPy_FEdgeSmooth *)obj1)->fes)); in FEdgeSmooth_init()
85 self->py_fe.fe = self->fes; in FEdgeSmooth_init()
86 self->py_fe.py_if1D.if1D = self->fes; in FEdgeSmooth_init()
104 Vec3r p(self->fes->normal()); in FEdgeSmooth_mathutils_get()
115 self->fes->setNormal(p); in FEdgeSmooth_mathutils_set()
122 Vec3r p(self->fes->normal()); in FEdgeSmooth_mathutils_get_index()
130 Vec3r p(self->fes->normal()); in FEdgeSmooth_mathutils_set_index()
132 self->fes->setNormal(p); in FEdgeSmooth_mathutils_set_index()
170 self->fes->setNormal(p); in FEdgeSmooth_normal_set()
[all …]
/dports/science/axom/axom-0.6.1/src/axom/sidre/examples/
H A Dsidre_mfem_datacollection_materials.cpp34 mfem::GridFunction* createAndInitGridFunction(mfem::FiniteElementSpace* fes, in createAndInitGridFunction() argument
38 auto* pfes = dynamic_cast<mfem::ParFiniteElementSpace*>(fes); in createAndInitGridFunction()
42 mfem::GridFunction* gf = new mfem::GridFunction(fes); in createAndInitGridFunction()
78 mfem::FiniteElementSpace* fes = in main() local
81 mfem::FiniteElementSpace* fes = new mfem::FiniteElementSpace(mesh, &fec); in main() local
111 mfem::GridFunction* vol_frac_1 = createAndInitGridFunction(fes, 0.65); in main()
112 mfem::GridFunction* vol_frac_2 = createAndInitGridFunction(fes, 0.35); in main()
118 mfem::GridFunction* density_independent = createAndInitGridFunction(fes, 1.0); in main()
119 mfem::GridFunction* density_dependent_1 = createAndInitGridFunction(fes, 0.2); in main()
120 mfem::GridFunction* density_dependent_2 = createAndInitGridFunction(fes, 0.3); in main()
[all …]
/dports/math/mfem/mfem-4.3/fem/tmop/
H A Dtmop_pa.cpp27 MFEM_VERIFY(PA.fes == &fes, ""); in AssembleGradPA()
64 const FiniteElementSpace *fes = PA.fes; in AssemblePA_Limiting() local
99 MFEM_VERIFY(nodes0->FESpace() == fes, ""); in AssemblePA_Limiting()
100 const Operator *n0_R = fes->GetElementRestriction(ordering); in AssemblePA_Limiting()
142 ComputeAllElementTargets_Fallback(fes, ir, xe, Jtr); in ComputeAllElementTargets()
170 const FiniteElementSpace *fes = PA.fes; in ComputeAllElementTargets() local
175 targetC->ComputeAllElementTargets(*fes, ir, xe, PA.Jtr); in ComputeAllElementTargets()
183 PA.fes = &fes; in AssemblePA()
184 Mesh *mesh = fes.GetMesh(); in AssemblePA()
192 const FiniteElement &fe = *fes.GetFE(0); in AssemblePA()
[all …]
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/source/hp/
H A Dfe_collection.cc28 const std::set<unsigned int> &fes, in find_common_fes() argument
33 for (const auto &fe : fes) in find_common_fes()
73 for (const auto &fe : fes) in find_enclosing_fes()
113 for (const auto &fe : fes) in find_dominating_fe()
121 if (fes.size() == 1) in find_dominating_fe()
122 return *fes.begin(); in find_dominating_fe()
159 for (const auto &fe : fes) in find_dominated_fe()
167 if (fes.size() == 1) in find_dominated_fe()
168 return *fes.begin(); in find_dominated_fe()
260 Assert(fes.size() > 0, in FECollection()
[all …]
/dports/math/mfem/mfem-4.3/tests/unit/fem/
H A Dtest_sum_bilin.cpp26 FiniteElementSpace fes(&mesh, &fec); variable
56 integ1.AssemblePA(fes);
57 integ2.AssemblePA(fes);
58 integ_sum.AssemblePA(fes);
60 int n = fes.GetTrueVSize();
98 integ1.AssembleMF(fes);
99 integ2.AssembleMF(fes);
100 integ_sum.AssembleMF(fes);
135 FiniteElementSpace fes(&mesh, &fec); variable
166 integ1.AssemblePAInteriorFaces(fes);
[all …]
/dports/science/plumed/plumed2-2.7.2/user-doc/tutorials/others/ves-lugano2017-metad/Example2/Bias_calculation/
H A Dplot.gpi35 pl "< paste fes.dat negativebias_1.dat" u 1:($2/2.494):(($2-$5)/2.494) w filledcurves ls 1 fillsty…
36 …"< paste fes.dat negativebias_1.dat negativebias_3.dat" u 1:(($2-$5)/2.494):(($2-$8)/2.494) w fil…
37 …"< paste fes.dat negativebias_3.dat negativebias_5.dat" u 1:(($2-$5)/2.494):(($2-$8)/2.494) w fil…
38 …"< paste fes.dat negativebias_5.dat negativebias_7.dat" u 1:(($2-$5)/2.494):(($2-$8)/2.494) w fil…
41 "< paste fes.dat negativebias_1.dat" u 1:(($2-$5)/2.494) w l ls 8 notitle, \
42 "< paste fes.dat negativebias_3.dat" u 1:(($2-$5)/2.494) w l ls 8 notitle, \
43 "< paste fes.dat negativebias_5.dat" u 1:(($2-$5)/2.494) w l ls 8 notitle, \
44 "< paste fes.dat negativebias_7.dat" u 1:(($2-$5)/2.494) w l ls 8 notitle, \
45 "< paste fes.dat negativebias_10.dat" u 1:(($2-$5)/2.494) w l ls 8 notitle, \
46 "< paste fes.dat negativebias_20.dat" u 1:(($2-$5)/2.494) w l ls 8 notitle, \
[all …]
/dports/math/mfem/mfem-4.3/tests/unit/linalg/
H A Dtest_matrix_square.cpp42 FiniteElementSpace fes(&mesh, fec); variable
47 fes.GetEssentialTrueDofs(ess_bdr, ess_tdof_list);
50 GridFunction x0(&fes), x1(&fes), b(&fes);
54 BilinearForm pa(&fes), fa(&fes);
113 ParFiniteElementSpace fes(pmesh, fec);
118 fes.GetEssentialTrueDofs(ess_bdr, ess_tdof_list);
121 ParGridFunction x0(&fes), x1(&fes), b(&fes);
125 ParBilinearForm pa(&fes), fa(&fes);
/dports/science/cp2k/cp2k-2e995eec7fd208c8a72d9544807bd8b8ba8cd1cc/src/metadyn_tools/
H A Dgraph_methods.F71 REAL(KIND=dp), DIMENSION(:), POINTER :: fes local
101 fes(pnt) = fes(pnt) + prod
129 REAL(KIND=dp), DIMENSION(:), POINTER :: fes local
182 sum_fes = sum_fes + fes(is)*dvol
239 sum_fes = sum_fes + fes(is)*dvol
317 fes_now = -fes(pnt)
335 fes_now = -fes(pnt)
342 do_save = fes(pnt) >= 1.0E-3_dp
436 fes_rep(irep) = -fes(pnt)
471 fes_rep(irep) = -fes(pnt)
[all …]
/dports/science/cp2k-data/cp2k-7.1.0/src/metadyn_tools/
H A Dgraph_methods.F71 REAL(KIND=dp), DIMENSION(:), POINTER :: fes local
101 fes(pnt) = fes(pnt) + prod
129 REAL(KIND=dp), DIMENSION(:), POINTER :: fes local
182 sum_fes = sum_fes + fes(is)*dvol
239 sum_fes = sum_fes + fes(is)*dvol
317 fes_now = -fes(pnt)
335 fes_now = -fes(pnt)
342 do_save = fes(pnt) >= 1.0E-3_dp
436 fes_rep(irep) = -fes(pnt)
471 fes_rep(irep) = -fes(pnt)
[all …]
/dports/science/ascent/ascent-0.7.1-66-gbcf2742a/src/examples/proxies/laghos/
H A Dlaghos_assembly.hpp176 MassPAOperator(QuadratureData *quad_data_, ParFiniteElementSpace &fes) in MassPAOperator() argument
177 : Operator(fes.GetVSize()), in MassPAOperator()
178 dim(fes.GetMesh()->Dimension()), nzones(fes.GetMesh()->GetNE()), in MassPAOperator()
179 quad_data(quad_data_), FESpace(fes) in MassPAOperator()
202 DiagonalSolver(ParFiniteElementSpace &fes) in DiagonalSolver() argument
203 : Solver(fes.GetVSize()), diag(), FESpace(fes) { } in DiagonalSolver()
235 LocalMassPAOperator(QuadratureData *quad_data_, ParFiniteElementSpace &fes) in LocalMassPAOperator() argument
236 : Operator(fes.GetFE(0)->GetDof()), in LocalMassPAOperator()
237 dim(fes.GetMesh()->Dimension()), zone_id(0), in LocalMassPAOperator()
/dports/science/axom/axom-0.6.1/src/axom/sidre/tests/
H A Dsidre_mfem_datacollection.cpp71 mfem::FiniteElementSpace fes(&mesh, &fec); in TEST() local
72 mfem::GridFunction gf(&fes); in TEST()
349 mfem::GridFunction vol_frac_1(&fes); in TEST()
374 mfem::GridFunction vol_frac_1(&fes); in TEST()
378 mfem::GridFunction vol_frac_2(&fes); in TEST()
405 mfem::GridFunction vol_frac_1(&fes); in TEST()
448 mfem::GridFunction vol_frac_1(&fes); in TEST()
451 mfem::GridFunction vol_frac_2(&fes); in TEST()
513 mfem::GridFunction vol_frac_1(&fes); in TEST()
551 mfem::GridFunction vol_frac_1(&fes); in TEST()
[all …]
/dports/science/ascent/ascent-0.7.1-66-gbcf2742a/src/examples/proxies/laghos/serial/
H A Dlaghos_assembly_s.hpp176 MassPAOperator(QuadratureData *quad_data_, FiniteElementSpace &fes) in MassPAOperator() argument
177 : Operator(fes.GetVSize()), in MassPAOperator()
178 dim(fes.GetMesh()->Dimension()), nzones(fes.GetMesh()->GetNE()), in MassPAOperator()
179 quad_data(quad_data_), FESpace(fes), ess_tdofs(NULL), in MassPAOperator()
180 x_gf(&fes), y_gf(&fes) in MassPAOperator()
212 LocalMassPAOperator(QuadratureData *quad_data_, FiniteElementSpace &fes) in LocalMassPAOperator() argument
213 : Operator(fes.GetFE(0)->GetDof()), in LocalMassPAOperator()
214 dim(fes.GetMesh()->Dimension()), zone_id(0), in LocalMassPAOperator()

12345678910>>...40