Home
last modified time | relevance | path

Searched refs:ldof (Results 1 – 24 of 24) sorted by relevance

/dports/math/alberta/alberta3-920315ae1bbfd1b1fb6672d916619ac37a411e95/alberta/src/3d/
H A Dparametric_3d.c1833 AXPBY_DOW(nodes[ldof][0], vec[v0dof], nodes[ldof][3], vec[re_dof], in project_ref_edgeY_3d()
2338 lambda[v0] = 1.0 - nodes[ldof][v1] - nodes[ldof][v2]; in adjust_center_nodesY_3d()
2454 act_proj->func(vec[dof[ldof]], el_info, cnodes[ldof]); in adjust_patch_center_nodesY_3d()
2476 act_proj->func(vec[dof[ldof]], el_info, cnodes[ldof]); in adjust_patch_center_nodesY_3d()
2618 act_proj->func(vec[dof[ldof]], el_info, cnodes[ldof]); in adjust_patch_wall_nodesY_3d()
2641 act_proj->func(vec[dof[ldof]], el_info, cnodes[ldof]); in adjust_patch_wall_nodesY_3d()
2711 act_proj->func(vec[dof[ldof]], el_info, cnodes[ldof]); in adjust_patch_wall_nodesY_3d()
2844 act_proj->func(vec[dof[ldof]], el_info, cnodes[ldof]); in all_projectY_3d()
2864 act_proj->func(vec[dof[ldof]], el_info, cnodes[ldof]); in all_projectY_3d()
2882 act_proj->func(vec[dof[ldof]], el_info, cnodes[ldof]); in all_projectY_3d()
[all …]
/dports/math/moab/fathomteam-moab-7bde9dfb84a8/src/Remapping/
H A DTempestOfflineMap.cpp231 dgll_cgll_col_ldofmap[ldof] = true; in SetDofMapAssociation()
311 dgll_cgll_col_ldofmap[ldof] = true; in SetDofMapAssociation()
372 dgll_cgll_covcol_ldofmap[ldof] = true; in SetDofMapAssociation()
375 col_dofmap[ idof ] = ldof; in SetDofMapAssociation()
376 col_ldofmap[ ldof ] = idof; in SetDofMapAssociation()
414 dgll_cgll_col_ldofmap[ldof] = true; in SetDofMapAssociation()
417 srccol_dofmap[ idof ] = ldof; in SetDofMapAssociation()
418 srccol_ldofmap[ ldof ] = idof; in SetDofMapAssociation()
455 dgll_cgll_row_ldofmap[ldof] = true; in SetDofMapAssociation()
458 row_dofmap[ idof ] = ldof; in SetDofMapAssociation()
[all …]
/dports/misc/elki/elki-release0.7.1-1166-gfb1fffdf3/elki-outlier/src/main/java/de/lmu/ifi/dbs/elki/algorithm/outlier/lof/
H A DLDOF.java155 double ldof = dxp.getMean() / Dxp.getMean(); in run() local
156 if(Double.isNaN(ldof) || Double.isInfinite(ldof)) { in run()
157 ldof = 1.0; in run()
159 ldofs.putDouble(iditer, ldof); in run()
161 ldofminmax.put(ldof); in run()
/dports/math/mfem/mfem-4.3/fem/
H A Dpfespace.cpp621 HYPRE_BigInt ldof[2]; in GenerateGlobalOffsets() local
624 ldof[0] = GetVSize(); in GenerateGlobalOffsets()
625 ldof[1] = TrueVSize(); in GenerateGlobalOffsets()
666 int ldof = GetVSize(); in Build_Dof_TrueDof_Matrix() local
844 MFEM_VERIFY(ldof_ltdof[ldof] >= 0, "ldof " << ldof << " not a true DOF."); in GetGlobalTDofNumber()
1105 ldof_marker[ldof] = i; in ExchangeFaceNbrData()
1111 send_J[j] = (send_J[j] >= 0 ? ldof_marker[ldof] : -1-ldof_marker[ldof]); in ExchangeFaceNbrData()
1204 if (ldof < 0) in ExchangeFaceNbrData()
1206 ldof = -1-ldof; in ExchangeFaceNbrData()
1249 vdofs[j] = (ldof >= 0) ? vol_vdofs[ldof] : -1-vol_vdofs[-1-ldof]; in GetFaceNbrFaceVDofs()
[all …]
H A Dpfespace.hpp356 int GetLocalTDofNumber(int ldof) const;
358 HYPRE_BigInt GetGlobalTDofNumber(int ldof) const;
H A Dpgridfunc.cpp235 const int ldof = d_send_ldof[i]; in ExchangeFaceNbrData()
236 d_send_data[i] = d_data[ldof >= 0 ? ldof : -1-ldof]; in ExchangeFaceNbrData()
H A Dfespace.cpp1387 int ldof = fe->GetDof(); in GetLocalRefinementMatrices() local
1393 localP.SetSize(ldof, ldof, nmat); in GetLocalRefinementMatrices()
1695 const int ldof = fe->GetDof(); in GetLocalDerefinementMatrices() local
1701 localR.SetSize(ldof, ldof, nmat); in GetLocalDerefinementMatrices()
H A Dgridfunc.cpp1966 int ldof; in AccumulateAndCountZones() local
1970 ldof = -1-vdofs[j]; in AccumulateAndCountZones()
1975 ldof = vdofs[j]; in AccumulateAndCountZones()
1983 (*this)(ldof) += isign / vals[j]; in AccumulateAndCountZones()
1987 (*this)(ldof) += isign*vals[j]; in AccumulateAndCountZones()
1992 zones_per_vdof[ldof]++; in AccumulateAndCountZones()
/dports/math/alberta/alberta3-920315ae1bbfd1b1fb6672d916619ac37a411e95/alberta/src/2d/
H A Dparametric_2d.c1005 lambda[v1] = 1.0 - nodes[ldof][v2]; in adjust_center_nodesY_2d()
1006 lambda[v2] = nodes[ldof][v2]; in adjust_center_nodesY_2d()
1016 AXPY_DOW(-scale*0.5*nodes[ldof][v1]/lambda[v1], d, vec[dof[ldof]]); in adjust_center_nodesY_2d()
1019 lambda[v1] = nodes[ldof][v1]; in adjust_center_nodesY_2d()
1020 lambda[v2] = 1.0 - nodes[ldof][v1]; in adjust_center_nodesY_2d()
1030 AXPY_DOW(-scale*0.5*nodes[ldof][v2]/lambda[v2], d, vec[dof[ldof]]); in adjust_center_nodesY_2d()
1201 act_proj->func(vec[dof[ldof]], el_info, cnodes[ldof]); in refine_interpolY_2d()
1357 nodes[ldof][voe[1]], vec1, in refine_interpolY_2d()
1358 vec[dof[ldof]]); in refine_interpolY_2d()
1365 AXEY_DOW(nodes[ldof][0], vec[dof[0]], vec[dof[ldof]]); in refine_interpolY_2d()
[all …]
/dports/math/mfem/mfem-4.3/tests/unit/fem/
H A Dtest_build_dof_to_arrays.cpp130 int ldof = (dofs[l] >= 0) ? dofs[l] : (-1 - dofs[l]); in to_string() local
132 if (i != ldof) { num_ldof_fails++; } in to_string()
235 int ldof = (dofs[l] >= 0) ? dofs[l] : (-1 - dofs[l]); in to_string() local
237 if (i != ldof) { num_ldof_fails++; } in to_string()
/dports/math/mfem/mfem-4.3/miniapps/navier/
H A Dnavier_tgv.cpp184 int ldof = dofs[j]; in ComputeQCriterion() local
185 q(ldof) += vals[j]; in ComputeQCriterion()
186 zones_per_vdof[ldof]++; in ComputeQCriterion()
H A Dnavier_solver.cpp722 int ldof = vdofs[j]; in ComputeCurl3D() local
723 cu(ldof) += vals[j]; in ComputeCurl3D()
724 zones_per_vdof[ldof]++; in ComputeCurl3D()
823 int ldof = vdofs[j]; in ComputeCurl2D() local
824 cu(ldof) += vals[j]; in ComputeCurl2D()
825 zones_per_vdof[ldof]++; in ComputeCurl2D()
/dports/math/alberta/alberta3-920315ae1bbfd1b1fb6672d916619ac37a411e95/add_ons/geomview/
H A Dgeomview-graphics.c1325 int ldof = N_VERTICES_2D+n_dof_e*i+j; in mesh2off_2d() local
1326 idx->vec[dofs[ldof]] = -1; /* mark as done */ in mesh2off_2d()
1333 int ldof = N_VERTICES_2D+n_dof_e*i+j; in mesh2off_2d() local
1335 edge[1+j] = idx->vec[dofs[ldof]]; in mesh2off_2d()
1336 idx->vec[dofs[ldof]] = -1; /* mark as done */ in mesh2off_2d()
2129 int ldof = N_VERTICES_3D+n_dof_e*i+j; in mesh2off_3d() local
2130 idx->vec[dofs[ldof]] = -1; /* mark as done */ in mesh2off_3d()
2137 int ldof = N_VERTICES_3D+n_dof_e*i+j; in mesh2off_3d() local
2139 if (idx->vec[dofs[ldof]] <= -2) { in mesh2off_3d()
2140 idx->vec[dofs[ldof]] = -idx->vec[dofs[ldof]]-2; in mesh2off_3d()
[all …]
/dports/math/alberta/alberta3-920315ae1bbfd1b1fb6672d916619ac37a411e95/add_ons/reparam_cm/src/Common/
H A Dgeomview-graphics.c1302 int ldof = N_VERTICES_2D+n_dof_e*i+j; in mesh2off_2d() local
1303 idx->vec[dofs[ldof]] = -1; /* mark as done */ in mesh2off_2d()
1310 int ldof = N_VERTICES_2D+n_dof_e*i+j; in mesh2off_2d() local
1312 edge[1+j] = idx->vec[dofs[ldof]]; in mesh2off_2d()
1313 idx->vec[dofs[ldof]] = -1; /* mark as done */ in mesh2off_2d()
2082 int ldof = N_VERTICES_3D+n_dof_e*i+j; in mesh2off_3d() local
2083 idx->vec[dofs[ldof]] = -1; /* mark as done */ in mesh2off_3d()
2090 int ldof = N_VERTICES_3D+n_dof_e*i+j; in mesh2off_3d() local
2092 if (idx->vec[dofs[ldof]] <= -2) { in mesh2off_3d()
2093 idx->vec[dofs[ldof]] = -idx->vec[dofs[ldof]]-2; in mesh2off_3d()
[all …]
/dports/math/alberta/alberta3-920315ae1bbfd1b1fb6672d916619ac37a411e95/demo/src/Common/
H A Dgeomview-graphics.c1326 int ldof = N_VERTICES_2D+n_dof_e*i+j; in mesh2off_2d() local
1327 idx->vec[dofs[ldof]] = -1; /* mark as done */ in mesh2off_2d()
1334 int ldof = N_VERTICES_2D+n_dof_e*i+j; in mesh2off_2d() local
1336 edge[1+j] = idx->vec[dofs[ldof]]; in mesh2off_2d()
1337 idx->vec[dofs[ldof]] = -1; /* mark as done */ in mesh2off_2d()
2107 int ldof = N_VERTICES_3D+n_dof_e*i+j; in mesh2off_3d() local
2108 idx->vec[dofs[ldof]] = -1; /* mark as done */ in mesh2off_3d()
2115 int ldof = N_VERTICES_3D+n_dof_e*i+j; in mesh2off_3d() local
2117 if (idx->vec[dofs[ldof]] <= -2) { in mesh2off_3d()
2118 idx->vec[dofs[ldof]] = -idx->vec[dofs[ldof]]-2; in mesh2off_3d()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/dm/impls/moab/
H A Ddmmbmg.cxx205 const int ldof = dmbc->lidmap[vhandle - dmbc->seqstart]; in DMCreateInterpolation_Moab() local
229 …if (dmbp->vghost->find(connp[ic]) != dmbp->vghost->end()) onz[ldof]++; /* update out-of-proc onz */ in DMCreateInterpolation_Moab()
230 else nnz[ldof]++; /* else local vertex */ in DMCreateInterpolation_Moab()
/dports/science/PETSc/petsc-3.14.1/src/dm/impls/plex/
H A Dplexpreallocate.c466 PetscInt ldof, rdof; in DMPlexCreateAdjacencySection_Static() local
468 ierr = PetscSectionGetDof(leafSectionAdj, off+d, &ldof);CHKERRQ(ierr); in DMPlexCreateAdjacencySection_Static()
470 if (ldof > 0) { in DMPlexCreateAdjacencySection_Static()
518 PetscInt ldof, rdof; in DMPlexCreateAdjacencySection_Static() local
520 ierr = PetscSectionGetDof(leafSectionAdj, off+d, &ldof);CHKERRQ(ierr); in DMPlexCreateAdjacencySection_Static()
522 if (ldof > 0) { in DMPlexCreateAdjacencySection_Static()
H A Dplexfem.c3476 PetscInt comp, coneSizeL, coneSizeR, faceLocL, faceLocR, ldof, rdof, d; in DMPlexGetFaceFields() local
3480 …ierr = DMPlexVecGetClosure(dm, section, locX, cells[0], &ldof, (PetscScalar **) &xL);CHKERRQ(ierr); in DMPlexGetFaceFields()
3493 …if (rdof == ldof && faceLocR < coneSizeR) {ierr = PetscFEEvaluateFaceFields_Internal(prob, f, face… in DMPlexGetFaceFields()
3501 …ierr = DMPlexVecRestoreClosure(dm, section, locX, cells[0], &ldof, (PetscScalar **) &xL);CHKERRQ(i… in DMPlexGetFaceFields()
/dports/math/R-cran-VGAM/VGAM/R/
H A Dfamily.univariate.R4758 ldof <- as.list(substitute(ldf)) functionVar
4759 edof <- link2list(ldof)
4760 ldof <- attr(edof, "function.name")
4818 }, list( .ldof = ldof, .edof = edof ))),
4824 }), list( .ldof = ldof,
4841 }, list( .ldof = ldof, .edof = edof ))),
4847 }, list( .ldof = ldof, .edof = edof ))),
4950 ldof <- as.list(substitute(ldf)) functionVar
4951 edof <- link2list(ldof)
4952 ldof <- attr(edof, "function.name")
[all …]
H A Dfamily.bivariate.R1214 ldof <- as.list(substitute(ldf)) functionVar
1215 edof <- link2list(ldof)
1216 ldof <- attr(edof, "function.name")
1243 namesof("df", ldof, earg = edof), ", ",
1345 .lrho = lrho, .ldof = ldof,
1353 } , list( .lrho = lrho, .ldof = ldof,
1384 .lrho = lrho, .ldof = ldof,
1411 }, list( .lrho = lrho, .ldof = ldof,
1423 }, list( .lrho = lrho, .ldof = ldof,
1478 }), list( .lrho = lrho, .ldof = ldof,
[all …]
/dports/science/PETSc/petsc-3.14.1/src/ksp/pc/impls/patch/
H A Dpcpatch.c873 PetscInt ldof, loff; in PCPatchGetPointDofs() local
889 …ierr = PCPatchGetGlobalDofs(pc, patch->dofSection, k, patch->combined, base, &ldof, &loff);CHKERRQ… in PCPatchGetPointDofs()
890 if (0 == ldof) continue; in PCPatchGetPointDofs()
891 for (j = loff; j < ldof + loff; ++j) { in PCPatchGetPointDofs()
905 …ierr = PCPatchGetGlobalDofs(pc, patch->dofSection, k, patch->combined, p, &ldof, &loff);CHKERRQ(ie… in PCPatchGetPointDofs()
906 if (0 == ldof) continue; in PCPatchGetPointDofs()
907 for (j = loff; j < ldof + loff; ++j) { in PCPatchGetPointDofs()
/dports/science/liggghts/LIGGGHTS-PUBLIC-3.8.0-26-g6e873439/lib/hotint/HotInt_V1/ElementsLib/beams/
H A DANCFCable2D.h845 virtual void SetArcLengthParameter(int elem, double load, int ldof);
H A DANCFCable2D.cpp3026 void ANCFCable2D::SetArcLengthParameter(int elem, double load, int ldof) in SetArcLengthParameter() argument
3030 loaddof = ldof; in SetArcLengthParameter()
/dports/math/mfem/mfem-4.3/mesh/
H A Dpmesh.cpp5845 const int ldof = (dofs[0] >= 0) ? dofs[0] : -1 - dofs[0]; in GetGlobalEdgeIndices() local
5846 gi[i] = fespace.GetGlobalTDofNumber(ldof); in GetGlobalEdgeIndices()
5873 const int ldof = (dofs[0] >= 0) ? dofs[0] : -1 - dofs[0]; in GetGlobalFaceIndices() local
5874 gi[i] = fespace.GetGlobalTDofNumber(ldof); in GetGlobalFaceIndices()