libMesh
|
Go to the source code of this file.
Classes | |
struct | DM_libMesh |
struct | DMVec_libMesh |
struct | token |
Functions | |
PetscErrorCode | DMlibMeshGetVec_Private (DM, const char *, Vec *) |
PetscErrorCode | DMlibMeshSetUpName_Private (DM dm) |
PetscErrorCode | DMlibMeshSetSystem_libMesh (DM dm, NonlinearImplicitSystem &sys) |
PetscErrorCode | DMlibMeshGetSystem_libMesh (DM dm, NonlinearImplicitSystem *&sys) |
PetscErrorCode | DMlibMeshGetBlocks (DM dm, PetscInt *n, char ***blocknames) |
PetscErrorCode | DMlibMeshGetVariables (DM dm, PetscInt *n, char ***varnames) |
static PetscErrorCode | DMCreateFieldDecomposition_libMesh (DM dm, PetscInt *len, char ***namelist, IS **islist, DM **dmlist) |
static PetscErrorCode | DMCreateDomainDecomposition_libMesh (DM dm, PetscInt *len, char ***namelist, IS **innerislist, IS **outerislist, DM **dmlist) |
PetscErrorCode | DMlibMeshCreateFieldDecompositionDM (DM dm, PetscInt dnumber, PetscInt *dsizes, char ***dvarlists, DM *ddm) |
PetscErrorCode | DMlibMeshCreateDomainDecompositionDM (DM dm, PetscInt dnumber, PetscInt *dsizes, char ***dblocklists, DM *ddm) |
static PetscErrorCode | DMlibMeshParseDecompositionDescriptor_Private (DM dm, const char *ddesc, PetscInt *dtype, PetscInt *dcount, PetscInt **dsizes, char ****dlists) |
static PetscErrorCode | DMCreateFieldDecompositionDM_libMesh (DM dm, const char *ddesc, DM *ddm) |
static PetscErrorCode | DMCreateDomainDecompositionDM_libMesh (DM dm, const char *ddesc, DM *ddm) |
static PetscErrorCode | DMlibMeshFunction (DM dm, Vec x, Vec r) |
static PetscErrorCode | SNESFunction_DMlibMesh (SNES, Vec x, Vec r, void *ctx) |
static PetscErrorCode | DMlibMeshJacobian (#if PETSC_RELEASE_LESS_THAN(3, 5, 0) DM dm, Vec x, Mat jac, Mat pc, MatStructure *msflag #else DM dm, Vec x, Mat jac, Mat pc #endif) |
static PetscErrorCode | SNESJacobian_DMlibMesh (#if PETSC_RELEASE_LESS_THAN(3, 5, 0) SNES, Vec x, Mat *jac, Mat *pc, MatStructure *flag, void *ctx #else SNES, Vec x, Mat jac, Mat pc, void *ctx #endif) |
static PetscErrorCode | DMVariableBounds_libMesh (DM dm, Vec xl, Vec xu) |
static PetscErrorCode | DMCreateGlobalVector_libMesh (DM dm, Vec *x) |
static PetscErrorCode | DMCreateMatrix_libMesh (DM dm, const MatType, Mat *A) static PetscErrorCode DMCreateMatrix_libMesh(DM dm |
CHKERRQ (ierr) | |
if (!eq) SETERRQ2(((PetscObject) dm) -> comm, PETSC_ERR_ARG_WRONG, "DM of type %s, not of type %s",((PetscObject) dm) ->type, DMLIBMESH) | |
if (!dlm->sys) SETERRQ(PETSC_COMM_WORLD | |
PetscFunctionReturn (0) | |
static PetscErrorCode | DMView_libMesh (DM dm, PetscViewer viewer) |
static PetscErrorCode | DMSetUp_libMesh (DM dm) |
static PetscErrorCode | DMDestroy_libMesh (DM dm) |
PetscErrorCode | DMCreate_libMesh (DM dm) |
Variables | |
static PetscErrorCode Mat * | A |
PetscErrorCode | ierr = PetscObjectTypeCompare((PetscObject)dm, DMLIBMESH, &eq) |
DM_libMesh * | dlm = (DM_libMesh *)(dm->data) |
PetscBool | eq |
PETSC_ERR_ARG_WRONGSTATE | |
No libMesh system set for | DM_libMesh |
CHKERRQ | ( | ierr | ) |
Referenced by DMlibMeshGetSystem(), and DMlibMeshSetSystem().
PetscErrorCode DMCreate_libMesh | ( | DM | dm | ) |
Definition at line 1170 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, DM_libMesh::blocknames, libMesh::CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, DMCreateDomainDecomposition_libMesh(), DMCreateDomainDecompositionDM_libMesh(), DMCreateFieldDecomposition_libMesh(), DMCreateFieldDecompositionDM_libMesh(), DMCreateGlobalVector_libMesh(), DMCreateMatrix_libMesh(), DMDestroy_libMesh(), DMlibMeshGetSystem_libMesh(), DMlibMeshSetSystem_libMesh(), DMSetUp_libMesh(), DMView_libMesh(), libMesh::ierr, PetscFunctionReturn(), DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by libMesh::LibMeshInit::LibMeshInit().
|
static |
Definition at line 378 of file petscdmlibmeshimpl.C.
References libMesh::MeshBase::active_local_subdomain_elements_begin(), libMesh::MeshBase::active_local_subdomain_elements_end(), DM_libMesh::blockids, DM_libMesh::blocknames, libMesh::CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, DMlibMeshSetUpName_Private(), libMesh::DofMap::dof_indices(), DM_libMesh::embedding, DM_libMesh::embedding_type, libMesh::DofMap::end_dof(), libMesh::DofMap::first_dof(), libMesh::System::get_dof_map(), libMesh::System::get_mesh(), libMesh::ierr, libMesh::index_range(), PETSC_OWN_POINTER, PetscFunctionReturn(), DM_libMesh::sys, DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by DMCreate_libMesh().
|
static |
Definition at line 764 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), DMlibMeshCreateDomainDecompositionDM(), DMlibMeshParseDecompositionDescriptor_Private(), libMesh::ierr, and PetscFunctionReturn().
Referenced by DMCreate_libMesh().
|
static |
Definition at line 272 of file petscdmlibmeshimpl.C.
References libMesh::MeshBase::active_local_subdomain_elements_begin(), libMesh::MeshBase::active_local_subdomain_elements_end(), libMesh::as_range(), DM_libMesh::blockids, DM_libMesh::blocknames, libMesh::CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, DMlibMeshSetUpName_Private(), libMesh::DofMap::dof_indices(), DM_libMesh::embedding, DM_libMesh::embedding_type, libMesh::DofMap::end_dof(), libMesh::DofMap::first_dof(), libMesh::System::get_dof_map(), libMesh::System::get_mesh(), libMesh::ierr, libMesh::index_range(), PETSC_OWN_POINTER, PetscFunctionReturn(), DM_libMesh::sys, DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by DMCreate_libMesh().
|
static |
Definition at line 745 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), DMlibMeshCreateFieldDecompositionDM(), DMlibMeshParseDecompositionDescriptor_Private(), libMesh::ierr, and PetscFunctionReturn().
Referenced by DMCreate_libMesh().
|
static |
Definition at line 980 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), dlm, DM_libMesh::embedding, eq, libMesh::ReferenceElem::get(), libMesh::ierr, PETSC_ERR_ARG_WRONGSTATE, PetscFunctionReturn(), libMesh::System::solution, DM_libMesh::sys, and libMesh::PetscVector< T >::vec().
Referenced by DMCreate_libMesh().
|
static |
Referenced by DMCreate_libMesh().
|
static |
Definition at line 1151 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, DM_libMesh::blocknames, libMesh::CHKERRQ(), DM_libMesh::decomposition, dlm, DM_libMesh::embedding, libMesh::ierr, PetscFunctionReturn(), DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by DMCreate_libMesh().
PetscErrorCode DMlibMeshCreateDomainDecompositionDM | ( | DM | dm, |
PetscInt | dnumber, | ||
PetscInt * | dsizes, | ||
char *** | dblocklists, | ||
DM * | ddm | ||
) |
Definition at line 540 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, DM_libMesh::blocknames, libMesh::CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, DMlibMeshSetUpName_Private(), libMesh::ierr, PetscFunctionReturn(), DM_libMesh::sys, DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by DMCreateDomainDecompositionDM_libMesh().
PetscErrorCode DMlibMeshCreateFieldDecompositionDM | ( | DM | dm, |
PetscInt | dnumber, | ||
PetscInt * | dsizes, | ||
char *** | dvarlists, | ||
DM * | ddm | ||
) |
Definition at line 488 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, DM_libMesh::blocknames, libMesh::CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, DMlibMeshSetUpName_Private(), libMesh::ierr, PetscFunctionReturn(), DM_libMesh::sys, DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by DMCreateFieldDecompositionDM_libMesh().
|
static |
Definition at line 786 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), libMesh::ParallelObject::comm(), libMesh::System::current_local_solution, DMlibMeshGetSystem(), libMesh::DofMap::enforce_constraints_exactly(), libMesh::System::get_dof_map(), libMesh::ierr, libMesh::libmesh_assert(), libMesh::NonlinearImplicitSystem::nonlinear_solver, PetscFunctionReturn(), libMesh::ExplicitSystem::rhs, libMesh::System::solution, libMesh::PetscVector< T >::swap(), and libMesh::System::update().
Referenced by DMSetUp_libMesh(), and SNESFunction_DMlibMesh().
PetscErrorCode DMlibMeshGetBlocks | ( | DM | dm, |
PetscInt * | n, | ||
char *** | blocknames | ||
) |
Definition at line 168 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, libMesh::CHKERRQ(), dlm, libMesh::ierr, and PetscFunctionReturn().
PetscErrorCode DMlibMeshGetSystem_libMesh | ( | DM | dm, |
NonlinearImplicitSystem *& | sys | ||
) |
Definition at line 151 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), dlm, libMesh::ierr, PetscFunctionReturn(), and DM_libMesh::sys.
Referenced by DMCreate_libMesh().
PetscErrorCode DMlibMeshGetVariables | ( | DM | dm, |
PetscInt * | n, | ||
char *** | varnames | ||
) |
Definition at line 193 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), dlm, libMesh::ierr, PetscFunctionReturn(), and DM_libMesh::varids.
PetscErrorCode DMlibMeshGetVec_Private | ( | DM | , |
const char * | , | ||
Vec * | |||
) |
Definition at line 77 of file petscdmlibmeshimpl.C.
References PetscFunctionReturn().
|
static |
Definition at line 856 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), libMesh::ParallelObject::comm(), libMesh::System::current_local_solution, DMlibMeshGetSystem(), libMesh::DofMap::enforce_constraints_exactly(), libMesh::System::get_dof_map(), libMesh::ierr, libMesh::ImplicitSystem::matrix, libMesh::NonlinearImplicitSystem::nonlinear_solver, PetscFunctionReturn(), libMesh::System::solution, libMesh::PetscVector< T >::swap(), and libMesh::System::update().
Referenced by DMSetUp_libMesh(), and SNESJacobian_DMlibMesh().
|
static |
Definition at line 601 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), eq, libMesh::ierr, token::next, PetscFunctionReturn(), and token::s.
Referenced by DMCreateDomainDecompositionDM_libMesh(), and DMCreateFieldDecompositionDM_libMesh().
PetscErrorCode DMlibMeshSetSystem_libMesh | ( | DM | dm, |
NonlinearImplicitSystem & | sys | ||
) |
Definition at line 90 of file petscdmlibmeshimpl.C.
References libMesh::MeshBase::active_element_ptr_range(), DM_libMesh::blockids, DM_libMesh::blocknames, libMesh::CHKERRQ(), libMesh::ParallelObject::comm(), dlm, DMlibMeshSetUpName_Private(), libMesh::System::get_dof_map(), libMesh::System::get_mesh(), libMesh::ierr, mesh, libMesh::DofMap::n_variables(), libMesh::Variable::name(), PETSC_ERR_ARG_WRONGSTATE, PetscFunctionReturn(), libMesh::MeshBase::subdomain_name(), DM_libMesh::sys, libMesh::DofMap::variable(), DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by DMCreate_libMesh().
PetscErrorCode DMlibMeshSetUpName_Private | ( | DM | dm | ) |
Definition at line 218 of file petscdmlibmeshimpl.C.
References DM_libMesh::blocknames, libMesh::CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, DM_libMesh::embedding_type, libMesh::ierr, libMesh::Quality::name(), libMesh::System::name(), PetscFunctionReturn(), DM_libMesh::sys, and DM_libMesh::varnames.
Referenced by DMCreateDomainDecomposition_libMesh(), DMCreateFieldDecomposition_libMesh(), DMlibMeshCreateDomainDecompositionDM(), DMlibMeshCreateFieldDecompositionDM(), and DMlibMeshSetSystem_libMesh().
|
static |
Definition at line 1107 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), dlm, DMlibMeshFunction(), DMlibMeshJacobian(), DMVariableBounds_libMesh(), DM_libMesh::embedding, eq, libMesh::ierr, libMesh::NonlinearImplicitSystem::nonlinear_solver, PETSC_ERR_ARG_WRONGSTATE, PetscFunctionReturn(), SNESFunction_DMlibMesh(), SNESJacobian_DMlibMesh(), and DM_libMesh::sys.
Referenced by DMCreate_libMesh().
|
static |
Definition at line 949 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), libMesh::ParallelObject::comm(), DMlibMeshGetSystem(), libMesh::ierr, libMesh::NonlinearImplicitSystem::nonlinear_solver, and PetscFunctionReturn().
Referenced by DMSetUp_libMesh().
|
static |
Definition at line 1048 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, libMesh::CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, end, libMesh::ierr, libMesh::index_range(), libMesh::Quality::name(), PetscFunctionReturn(), and DM_libMesh::varids.
Referenced by DMCreate_libMesh().
if | ( | !dlm-> | sys | ) |
if | ( | ! | eq | ) | -> comm, PETSC_ERR_ARG_WRONG, "DM of type %s, not of type %s",((PetscObject) dm) ->type, DMLIBMESH) |
PetscFunctionReturn | ( | 0 | ) |
Referenced by DMCreate_libMesh(), DMCreateDomainDecomposition_libMesh(), DMCreateDomainDecompositionDM_libMesh(), DMCreateFieldDecomposition_libMesh(), DMCreateFieldDecompositionDM_libMesh(), DMCreateGlobalVector_libMesh(), DMDestroy_libMesh(), DMlibMeshCreateDomainDecompositionDM(), DMlibMeshCreateFieldDecompositionDM(), DMlibMeshFunction(), DMlibMeshGetBlocks(), DMlibMeshGetSystem(), DMlibMeshGetSystem_libMesh(), DMlibMeshGetVariables(), DMlibMeshGetVec_Private(), DMlibMeshJacobian(), DMlibMeshParseDecompositionDescriptor_Private(), DMlibMeshSetSystem(), DMlibMeshSetSystem_libMesh(), DMlibMeshSetUpName_Private(), DMSetUp_libMesh(), DMVariableBounds_libMesh(), DMView_libMesh(), SNESFunction_DMlibMesh(), and SNESJacobian_DMlibMesh().
|
static |
Definition at line 843 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), libMesh::ctx, DMlibMeshFunction(), libMesh::ierr, and PetscFunctionReturn().
Referenced by DMSetUp_libMesh().
|
static |
Definition at line 927 of file petscdmlibmeshimpl.C.
References libMesh::CHKERRQ(), libMesh::ctx, DMlibMeshJacobian(), libMesh::ierr, and PetscFunctionReturn().
Referenced by DMSetUp_libMesh().
* A |
Definition at line 1026 of file petscdmlibmeshimpl.C.
Referenced by libMesh::DenseMatrix< Real >::_cholesky_back_substitute(), libMesh::DenseMatrix< Real >::_cholesky_decompose(), GETPOT_NAMESPACE::GetPot::_DBE_expand(), libMesh::DenseMatrix< Real >::_lu_back_substitute(), libMesh::DenseMatrix< Real >::_lu_decompose(), libMesh::DenseMatrix< Real >::_multiply_blas(), libMesh::EpetraVector< T >::add_vector(), libMesh::PetscVector< libMesh::Number >::add_vector(), libMesh::PetscVector< libMesh::Number >::add_vector_transpose(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_single_point_map(), libMesh::QMonomial::init_3D(), libMesh::FESubdivision::init_shape_functions(), libMesh::FESubdivision::init_subdivision_matrix(), libMesh::TypeTensor< T >::inverse(), libMesh::DenseMatrix< Real >::left_multiply_transpose(), libMesh::VariationalMeshSmoother::minJ(), libMesh::RadialBasisInterpolation< KDDim, RBF >::prepare_for_use(), libMesh::Hex::quality(), libMesh::Quad::quality(), libMesh::DenseMatrix< Real >::right_multiply_transpose(), DenseMatrixTest::testComplexSVD(), DenseMatrixTest::testEVD_helper(), DenseMatrixTest::testEVDcomplex(), DenseMatrixTest::testEVDreal(), DenseMatrixTest::testSubMatrix(), DenseMatrixTest::testSVD(), and libMesh::Edge3::volume().
DM_libMesh* dlm = (DM_libMesh *)(dm->data) |
Definition at line 1029 of file petscdmlibmeshimpl.C.
Referenced by DMCreate_libMesh(), DMCreateDomainDecomposition_libMesh(), DMCreateFieldDecomposition_libMesh(), DMCreateGlobalVector_libMesh(), DMDestroy_libMesh(), DMlibMeshCreateDomainDecompositionDM(), DMlibMeshCreateFieldDecompositionDM(), DMlibMeshGetBlocks(), DMlibMeshGetSystem_libMesh(), DMlibMeshGetVariables(), DMlibMeshSetSystem_libMesh(), DMlibMeshSetUpName_Private(), DMSetUp_libMesh(), and DMView_libMesh().
No libMesh system set for DM_libMesh |
Definition at line 1038 of file petscdmlibmeshimpl.C.
PetscBool eq |
Definition at line 1030 of file petscdmlibmeshimpl.C.
Referenced by DMCreateGlobalVector_libMesh(), DMlibMeshParseDecompositionDescriptor_Private(), and DMSetUp_libMesh().
ierr = PetscObjectTypeCompare((PetscObject)dm, DMLIBMESH, &eq) |
Definition at line 1028 of file petscdmlibmeshimpl.C.
Referenced by libMesh::PetscMatrix< libMesh::Number >::_get_submatrix(), libMesh::PetscLinearSolver< Number >::_petsc_shell_matrix_get_diagonal(), libMesh::SlepcEigenSolver< libMesh::Number >::_petsc_shell_matrix_get_diagonal(), libMesh::PetscLinearSolver< Number >::_petsc_shell_matrix_mult(), libMesh::SlepcEigenSolver< libMesh::Number >::_petsc_shell_matrix_mult(), libMesh::PetscLinearSolver< Number >::_petsc_shell_matrix_mult_add(), libMesh::SlepcEigenSolver< libMesh::Number >::_solve_generalized_helper(), libMesh::SlepcEigenSolver< libMesh::Number >::_solve_standard_helper(), libMesh::PetscMatrix< libMesh::Number >::add(), libMesh::PetscMatrix< libMesh::Number >::add_block_matrix(), libMesh::PetscMatrix< libMesh::Number >::add_matrix(), libMesh::PetscLinearSolver< Number >::adjoint_solve(), libMesh::SlepcEigenSolver< libMesh::Number >::attach_deflation_space(), libMesh::PetscNonlinearSolver< Number >::build_mat_null_space(), libMesh::SlepcEigenSolver< libMesh::Number >::clear(), libMesh::PetscNonlinearSolver< Number >::clear(), libMesh::PetscLinearSolver< Number >::clear(), libMesh::PetscVector< libMesh::Number >::clear(), libMesh::PetscMatrix< libMesh::Number >::clear(), libMesh::PetscVector< libMesh::Number >::close(), libMesh::PetscMatrix< libMesh::Number >::close(), libMesh::PetscMatrix< libMesh::Number >::closed(), DMlibMeshGetSystem(), DMlibMeshSetSystem(), libMesh::PetscVector< libMesh::Number >::first_local_index(), libMesh::PetscMatrix< libMesh::Number >::flush(), libMesh::PetscNonlinearSolver< Number >::get_converged_reason(), libMesh::PetscMatrix< libMesh::Number >::get_diagonal(), libMesh::SlepcEigenSolver< libMesh::Number >::get_eigenpair(), libMesh::SlepcEigenSolver< libMesh::Number >::get_eigenvalue(), libMesh::PetscLinearSolver< Number >::get_initial_residual(), libMesh::PetscMatrix< libMesh::Number >::get_local_size(), libMesh::SlepcEigenSolver< libMesh::Number >::get_relative_error(), libMesh::PetscLinearSolver< Number >::get_residual_history(), libMesh::PetscMatrix< libMesh::Number >::get_row(), libMesh::PetscMatrix< libMesh::Number >::get_transpose(), libMesh::SlepcEigenSolver< libMesh::Number >::init(), libMesh::PetscMatrix< libMesh::Number >::init(), libMesh::PetscNonlinearSolver< Number >::init(), libMesh::PetscLinearSolver< Number >::init(), libMesh::PetscVector< libMesh::Number >::init(), libMesh::PetscMatrix< libMesh::Number >::l1_norm(), libMesh::PetscVector< libMesh::Number >::last_local_index(), libMesh::PetscMatrix< libMesh::Number >::linfty_norm(), libMesh::PetscMatrix< libMesh::Number >::local_m(), libMesh::PetscMatrix< libMesh::Number >::local_n(), libMesh::PetscVector< libMesh::Number >::local_size(), libMesh::PetscMatrix< libMesh::Number >::m(), libMesh::PetscVector< libMesh::Number >::map_global_to_local_index(), libMesh::PetscVector< libMesh::Number >::max(), libMesh::PetscVector< libMesh::Number >::min(), libMesh::PetscMatrix< libMesh::Number >::n(), libMesh::PetscMatrix< libMesh::Number >::operator()(), libMesh::PetscVector< libMesh::Number >::PetscVector(), libMesh::PetscMatrix< libMesh::Number >::print_matlab(), libMesh::PetscMatrix< libMesh::Number >::print_personal(), libMesh::PetscMatrix< libMesh::Number >::reset_preallocation(), libMesh::PetscLinearSolver< Number >::restrict_solve_to(), libMesh::PetscMatrix< libMesh::Number >::row_start(), libMesh::PetscMatrix< libMesh::Number >::row_stop(), libMesh::PetscMatrix< libMesh::Number >::set(), libMesh::SlepcEigenSolver< libMesh::Number >::set_initial_space(), libMesh::PetscLinearSolver< Number >::set_petsc_solver_type(), libMesh::SlepcEigenSolver< libMesh::Number >::set_slepc_position_of_spectrum(), libMesh::SlepcEigenSolver< libMesh::Number >::set_slepc_problem_type(), libMesh::SlepcEigenSolver< libMesh::Number >::set_slepc_solver_type(), libMesh::PetscVector< libMesh::Number >::size(), libMesh::PetscNonlinearSolver< Number >::solve(), libMesh::PetscLinearSolver< Number >::solve(), libMesh::SlepcEigenSolver< libMesh::Number >::solve_generalized(), libMesh::SlepcEigenSolver< libMesh::Number >::solve_standard(), libMesh::PetscVector< libMesh::Number >::zero(), libMesh::PetscMatrix< libMesh::Number >::zero(), and libMesh::PetscMatrix< libMesh::Number >::zero_rows().
PETSC_ERR_ARG_WRONGSTATE |
Definition at line 1038 of file petscdmlibmeshimpl.C.
Referenced by DMCreateGlobalVector_libMesh(), DMlibMeshSetSystem_libMesh(), and DMSetUp_libMesh().