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 DMCreate_libMesh(), DMCreateDomainDecomposition_libMesh(), DMCreateDomainDecompositionDM_libMesh(), DMCreateFieldDecomposition_libMesh(), DMCreateFieldDecompositionDM_libMesh(), DMCreateGlobalVector_libMesh(), DMDestroy_libMesh(), DMlibMeshCreateDomainDecompositionDM(), DMlibMeshCreateFieldDecompositionDM(), DMlibMeshFunction(), DMlibMeshGetBlocks(), DMlibMeshGetSystem(), DMlibMeshGetSystem_libMesh(), DMlibMeshGetVariables(), DMlibMeshJacobian(), DMlibMeshParseDecompositionDescriptor_Private(), DMlibMeshSetSystem(), DMlibMeshSetSystem_libMesh(), DMlibMeshSetUpName_Private(), DMSetUp_libMesh(), DMVariableBounds_libMesh(), DMView_libMesh(), libmesh_petsc_preconditioner_apply(), libmesh_petsc_preconditioner_setup(), SNESFunction_DMlibMesh(), and SNESJacobian_DMlibMesh().
PetscErrorCode DMCreate_libMesh | ( | DM | dm | ) |
Definition at line 1164 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, DM_libMesh::blocknames, 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(), ierr, PetscFunctionReturn(), DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by libMesh::LibMeshInit::LibMeshInit().
|
static |
Definition at line 374 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, 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(), ierr, PETSC_OWN_POINTER, PetscFunctionReturn(), DM_libMesh::sys, DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by DMCreate_libMesh().
|
static |
Definition at line 760 of file petscdmlibmeshimpl.C.
References CHKERRQ(), DMlibMeshCreateDomainDecompositionDM(), DMlibMeshParseDecompositionDescriptor_Private(), ierr, and PetscFunctionReturn().
Referenced by DMCreate_libMesh().
|
static |
Definition at line 267 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, 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(), ierr, PETSC_OWN_POINTER, PetscFunctionReturn(), DM_libMesh::sys, DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by DMCreate_libMesh().
|
static |
Definition at line 741 of file petscdmlibmeshimpl.C.
References CHKERRQ(), DMlibMeshCreateFieldDecompositionDM(), DMlibMeshParseDecompositionDescriptor_Private(), ierr, and PetscFunctionReturn().
Referenced by DMCreate_libMesh().
|
static |
Definition at line 974 of file petscdmlibmeshimpl.C.
References CHKERRQ(), dlm, DM_libMesh::embedding, eq, 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 1145 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, DM_libMesh::blocknames, CHKERRQ(), DM_libMesh::decomposition, dlm, DM_libMesh::embedding, 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 536 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, DM_libMesh::blocknames, CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, DMlibMeshSetUpName_Private(), 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 484 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, DM_libMesh::blocknames, CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, DMlibMeshSetUpName_Private(), ierr, PetscFunctionReturn(), DM_libMesh::sys, DM_libMesh::varids, and DM_libMesh::varnames.
Referenced by DMCreateFieldDecompositionDM_libMesh().
|
static |
Definition at line 782 of file petscdmlibmeshimpl.C.
References CHKERRQ(), libMesh::ParallelObject::comm(), libMesh::System::current_local_solution, DMlibMeshGetSystem(), libMesh::DofMap::enforce_constraints_exactly(), libMesh::System::get_dof_map(), ierr, 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 167 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, CHKERRQ(), dlm, ierr, and PetscFunctionReturn().
PetscErrorCode DMlibMeshGetSystem_libMesh | ( | DM | dm, |
NonlinearImplicitSystem *& | sys | ||
) |
Definition at line 150 of file petscdmlibmeshimpl.C.
References CHKERRQ(), dlm, ierr, PetscFunctionReturn(), and DM_libMesh::sys.
Referenced by DMCreate_libMesh().
PetscErrorCode DMlibMeshGetVariables | ( | DM | dm, |
PetscInt * | n, | ||
char *** | varnames | ||
) |
Definition at line 192 of file petscdmlibmeshimpl.C.
References CHKERRQ(), dlm, ierr, PetscFunctionReturn(), and DM_libMesh::varids.
PetscErrorCode DMlibMeshGetVec_Private | ( | DM | , |
const char * | , | ||
Vec * | |||
) |
Definition at line 76 of file petscdmlibmeshimpl.C.
References PetscFunctionReturn().
|
static |
Definition at line 852 of file petscdmlibmeshimpl.C.
References CHKERRQ(), libMesh::ParallelObject::comm(), libMesh::System::current_local_solution, DMlibMeshGetSystem(), libMesh::DofMap::enforce_constraints_exactly(), libMesh::System::get_dof_map(), 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 597 of file petscdmlibmeshimpl.C.
References CHKERRQ(), eq, ierr, token::next, PetscFunctionReturn(), and token::s.
Referenced by DMCreateDomainDecompositionDM_libMesh(), and DMCreateFieldDecompositionDM_libMesh().
PetscErrorCode DMlibMeshSetSystem_libMesh | ( | DM | dm, |
NonlinearImplicitSystem & | sys | ||
) |
Definition at line 89 of file petscdmlibmeshimpl.C.
References libMesh::MeshBase::active_element_ptr_range(), DM_libMesh::blockids, DM_libMesh::blocknames, CHKERRQ(), libMesh::ParallelObject::comm(), dlm, DMlibMeshSetUpName_Private(), libMesh::System::get_dof_map(), libMesh::System::get_mesh(), ierr, mesh, libMesh::DofMap::n_variables(), libMesh::Variable::name(), PETSC_ERR_ARG_WRONGSTATE, PetscFunctionReturn(), libMesh::Parallel::Communicator::set_union(), 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 217 of file petscdmlibmeshimpl.C.
References DM_libMesh::blocknames, CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, DM_libMesh::embedding_type, end, 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 1101 of file petscdmlibmeshimpl.C.
References CHKERRQ(), dlm, DMlibMeshFunction(), DMlibMeshJacobian(), DMVariableBounds_libMesh(), DM_libMesh::embedding, eq, 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 945 of file petscdmlibmeshimpl.C.
References CHKERRQ(), libMesh::ParallelObject::comm(), DMlibMeshGetSystem(), ierr, libMesh::NonlinearImplicitSystem::nonlinear_solver, and PetscFunctionReturn().
Referenced by DMSetUp_libMesh().
|
static |
Definition at line 1042 of file petscdmlibmeshimpl.C.
References DM_libMesh::blockids, CHKERRQ(), DM_libMesh::decomposition, DM_libMesh::decomposition_type, dlm, end, ierr, libMesh::Quality::name(), PetscFunctionReturn(), and DM_libMesh::varids.
Referenced by DMCreate_libMesh().
if | ( | ! | eq | ) | -> comm, PETSC_ERR_ARG_WRONG, "DM of type %s, not of type %s",((PetscObject) dm) ->type, DMLIBMESH) |
Referenced by libMesh::Nemesis_IO_Helper::write_element_values().
if | ( | !dlm-> | sys | ) |
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 839 of file petscdmlibmeshimpl.C.
References CHKERRQ(), DMlibMeshFunction(), ierr, and PetscFunctionReturn().
Referenced by DMSetUp_libMesh().
|
static |
Definition at line 923 of file petscdmlibmeshimpl.C.
References CHKERRQ(), DMlibMeshJacobian(), ierr, and PetscFunctionReturn().
Referenced by DMSetUp_libMesh().
* A |
Definition at line 1020 of file petscdmlibmeshimpl.C.
Referenced by libMesh::DenseMatrix< Number >::_cholesky_back_substitute(), libMesh::DenseMatrix< Number >::_cholesky_decompose(), GETPOT_NAMESPACE::GetPot::_DBE_expand(), libMesh::DenseMatrix< Number >::_lu_back_substitute(), libMesh::DenseMatrix< Number >::_lu_decompose(), libMesh::DenseMatrix< Number >::_multiply_blas(), libMesh::EpetraVector< T >::add_vector(), libMesh::PetscVector< T >::add_vector(), libMesh::PetscVector< T >::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< Number >::left_multiply_transpose(), libMesh::VariationalMeshSmoother::minJ(), libMesh::Quad::quality(), libMesh::DenseMatrix< Number >::right_multiply_transpose(), and libMesh::Edge3::volume().
DM_libMesh* dlm = (DM_libMesh *)(dm->data) |
Definition at line 1023 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 1032 of file petscdmlibmeshimpl.C.
PetscBool eq |
Definition at line 1024 of file petscdmlibmeshimpl.C.
Referenced by DMCreateGlobalVector_libMesh(), DMlibMeshParseDecompositionDescriptor_Private(), and DMSetUp_libMesh().
ierr = PetscObjectTypeCompare((PetscObject)dm, DMLIBMESH, &eq) |
Definition at line 1022 of file petscdmlibmeshimpl.C.
Referenced by libMesh::__libmesh_petsc_diff_solver_monitor(), libMesh::__libmesh_tao_equality_constraints(), libMesh::__libmesh_tao_equality_constraints_jacobian(), libMesh::__libmesh_tao_gradient(), libMesh::__libmesh_tao_hessian(), libMesh::__libmesh_tao_inequality_constraints(), libMesh::__libmesh_tao_inequality_constraints_jacobian(), libMesh::__libmesh_tao_objective(), libMesh::PetscLinearSolver< T >::_create_complement_is(), libMesh::PetscVector< T >::_get_array(), libMesh::PetscMatrix< T >::_get_submatrix(), libMesh::SlepcEigenSolver< T >::_petsc_shell_matrix_get_diagonal(), libMesh::PetscLinearSolver< T >::_petsc_shell_matrix_get_diagonal(), libMesh::SlepcEigenSolver< T >::_petsc_shell_matrix_mult(), libMesh::PetscLinearSolver< T >::_petsc_shell_matrix_mult(), libMesh::PetscLinearSolver< T >::_petsc_shell_matrix_mult_add(), libMesh::PetscVector< T >::_restore_array(), libMesh::PetscLinearSolver< T >::_restrict_solve_to_is_local_size(), libMesh::SlepcEigenSolver< T >::_solve_generalized_helper(), libMesh::SlepcEigenSolver< T >::_solve_standard_helper(), libMesh::PetscVector< T >::abs(), libMesh::PetscMatrix< T >::add(), libMesh::PetscVector< T >::add(), libMesh::PetscMatrix< T >::add_block_matrix(), libMesh::PetscDMWrapper::add_dofs_helper(), libMesh::PetscDMWrapper::add_dofs_to_section(), libMesh::PetscMatrix< T >::add_matrix(), libMesh::PetscVector< T >::add_vector(), libMesh::PetscVector< T >::add_vector_transpose(), libMesh::PetscLinearSolver< T >::adjoint_solve(), libMesh::PetscPreconditioner< T >::apply(), libMesh::SlepcEigenSolver< T >::attach_deflation_space(), libMesh::PetscNonlinearSolver< Number >::build_mat_null_space(), libMesh::PetscDMWrapper::build_section(), libMesh::PetscDMWrapper::build_sf(), libMesh::PetscDMWrapper::check_section_n_dofs(), libMesh::SlepcEigenSolver< T >::clear(), libMesh::PetscPreconditioner< T >::clear(), libMesh::PetscDiffSolver::clear(), libMesh::TaoOptimizationSolver< T >::clear(), libMesh::PetscNonlinearSolver< Number >::clear(), libMesh::PetscLinearSolver< T >::clear(), libMesh::PetscVector< T >::clear(), libMesh::PetscMatrix< T >::clear(), libMesh::PetscVector< T >::close(), libMesh::PetscMatrix< T >::close(), libMesh::PetscMatrix< T >::closed(), libMesh::PetscVector< T >::conjugate(), libMesh::PetscVector< T >::create_subvector(), DMCreate_libMesh(), DMCreateDomainDecomposition_libMesh(), DMCreateDomainDecompositionDM_libMesh(), DMCreateFieldDecomposition_libMesh(), DMCreateFieldDecompositionDM_libMesh(), DMCreateGlobalVector_libMesh(), DMDestroy_libMesh(), DMlibMeshCreateDomainDecompositionDM(), DMlibMeshCreateFieldDecompositionDM(), DMlibMeshFunction(), DMlibMeshGetBlocks(), DMlibMeshGetSystem(), DMlibMeshGetSystem_libMesh(), DMlibMeshGetVariables(), DMlibMeshJacobian(), DMlibMeshParseDecompositionDescriptor_Private(), DMlibMeshSetSystem(), DMlibMeshSetSystem_libMesh(), DMlibMeshSetUpName_Private(), DMSetUp_libMesh(), DMVariableBounds_libMesh(), DMView_libMesh(), libMesh::PetscVector< T >::dot(), libMesh::PetscVector< T >::first_local_index(), libMesh::PetscMatrix< T >::flush(), libMesh::TaoOptimizationSolver< T >::get_converged_reason(), libMesh::PetscNonlinearSolver< Number >::get_converged_reason(), libMesh::PetscMatrix< T >::get_diagonal(), libMesh::TaoOptimizationSolver< T >::get_dual_variables(), libMesh::SlepcEigenSolver< T >::get_eigenpair(), libMesh::SlepcEigenSolver< T >::get_eigenvalue(), libMesh::PetscLinearSolver< T >::get_initial_residual(), libMesh::SlepcEigenSolver< T >::get_relative_error(), libMesh::PetscLinearSolver< T >::get_residual_history(), libMesh::PetscMatrix< T >::get_transpose(), libMesh::PetscVector< T >::indefinite_dot(), libMesh::SlepcEigenSolver< T >::init(), libMesh::PetscPreconditioner< T >::init(), libMesh::TaoOptimizationSolver< T >::init(), libMesh::PetscMatrix< T >::init(), libMesh::PetscNonlinearSolver< Number >::init(), libMesh::PetscLinearSolver< T >::init(), libMesh::PetscVector< T >::init(), libMesh::PetscDMWrapper::init_and_attach_petscdm(), libMesh::PetscVector< T >::insert(), libMesh::PetscVector< T >::l1_norm(), libMesh::PetscMatrix< T >::l1_norm(), libMesh::PetscVector< T >::l2_norm(), libMesh::PetscVector< T >::last_local_index(), libmesh_petsc_preconditioner_apply(), libmesh_petsc_preconditioner_setup(), libMesh::libmesh_petsc_snes_jacobian(), libMesh::libmesh_petsc_snes_postcheck(), libMesh::libmesh_petsc_snes_residual_helper(), libMesh::LibMeshInit::LibMeshInit(), libMesh::PetscVector< T >::linfty_norm(), libMesh::PetscMatrix< T >::linfty_norm(), libMesh::PetscVector< T >::local_size(), libMesh::PetscVector< T >::localize(), libMesh::PetscVector< T >::localize_to_one(), libMesh::PetscMatrix< T >::m(), libMesh::PetscVector< T >::map_global_to_local_index(), libMesh::PetscVector< T >::max(), libMesh::PetscVector< T >::min(), libMesh::PetscMatrix< T >::n(), libMesh::PetscMatrix< T >::operator()(), libMesh::PetscVector< T >::operator/=(), libMesh::PetscVector< T >::operator=(), libMesh::PetscVector< T >::PetscVector(), libMesh::PetscVector< T >::pointwise_mult(), libMesh::PetscMatrix< T >::print_matlab(), libMesh::PetscVector< T >::print_matlab(), libMesh::PetscMatrix< T >::print_personal(), libMesh::GMVIO::read(), libMesh::PetscVector< T >::reciprocal(), libMesh::PetscLinearSolver< T >::restrict_solve_to(), libMesh::PetscMatrix< T >::row_start(), libMesh::PetscMatrix< T >::row_stop(), libMesh::PetscVector< T >::scale(), libMesh::PetscMatrix< T >::set(), libMesh::PetscVector< T >::set(), libMesh::SlepcEigenSolver< T >::set_initial_space(), libMesh::PetscPreconditioner< T >::set_petsc_preconditioner_type(), libMesh::PetscLinearSolver< T >::set_petsc_solver_type(), libMesh::PetscDMWrapper::set_point_range_in_section(), libMesh::SlepcEigenSolver< T >::set_slepc_position_of_spectrum(), libMesh::SlepcEigenSolver< T >::set_slepc_problem_type(), libMesh::SlepcEigenSolver< T >::set_slepc_solver_type(), libMesh::PetscDiffSolver::setup_petsc_data(), libMesh::PetscVector< T >::size(), SNESFunction_DMlibMesh(), SNESJacobian_DMlibMesh(), libMesh::PetscDiffSolver::solve(), libMesh::TaoOptimizationSolver< T >::solve(), libMesh::NloptOptimizationSolver< T >::solve(), libMesh::PetscNonlinearSolver< Number >::solve(), libMesh::PetscLinearSolver< T >::solve(), libMesh::SlepcEigenSolver< T >::solve_generalized(), libMesh::SlepcEigenSolver< T >::solve_standard(), libMesh::PetscVector< T >::sum(), libMesh::TecplotIO::write_binary(), libMesh::PetscVector< T >::zero(), libMesh::PetscMatrix< T >::zero(), and libMesh::PetscMatrix< T >::zero_rows().
PETSC_ERR_ARG_WRONGSTATE |
Definition at line 1032 of file petscdmlibmeshimpl.C.
Referenced by DMCreateGlobalVector_libMesh(), DMlibMeshSetSystem_libMesh(), and DMSetUp_libMesh().