2012-05-30 5 views
5

私はPETScライブラリを使用して、方程式の線形システムを並列に解き始めています。私はすべてのパッケージをインストールし、petsc/src/ksp/ksp/examples/tutorials/folderの例を構築して正常に実行しました。例えば、ex.ckspガイド付きPETSc解法リニアシステム

しかし、行列A、Xを満たす方法を理解できませんでした例えばファイルからそれらを読み取ることによって、

ここで私はex2.cファイル内のコードを提供します。

/* Program usage: mpiexec -n <procs> ex2 [-help] [all PETSc options] */ 

static char help[] = "Solves a linear system in parallel with KSP.\n\ 
Input parameters include:\n\ 
    -random_exact_sol : use a random exact solution vector\n\ 
    -view_exact_sol : write exact solution vector to stdout\n\ 
    -m <mesh_x>  : number of mesh points in x-direction\n\ 
    -n <mesh_n>  : number of mesh points in y-direction\n\n"; 

/*T 
    Concepts: KSP^basic parallel example; 
    Concepts: KSP^Laplacian, 2d 
    Concepts: Laplacian, 2d 
    Processors: n 
T*/ 

/* 
    Include "petscksp.h" so that we can use KSP solvers. Note that this file 
    automatically includes: 
    petscsys.h  - base PETSc routines petscvec.h - vectors 
    petscmat.h - matrices 
    petscis.h  - index sets   petscksp.h - Krylov subspace methods 
    petscviewer.h - viewers    petscpc.h - preconditioners 
*/ 
#include <C:\PETSC\include\petscksp.h> 

#undef __FUNCT__ 
#define __FUNCT__ "main" 
int main(int argc,char **args) 
{ 
    Vec   x,b,u; /* approx solution, RHS, exact solution */ 
    Mat   A;  /* linear system matrix */ 
    KSP   ksp;  /* linear solver context */ 
    PetscRandom rctx;  /* random number generator context */ 
    PetscReal  norm;  /* norm of solution error */ 
    PetscInt  i,j,Ii,J,Istart,Iend,m = 8,n = 7,its; 
    PetscErrorCode ierr; 
    PetscBool  flg = PETSC_FALSE; 
    PetscScalar v; 
#if defined(PETSC_USE_LOG) 
    PetscLogStage stage; 
#endif 

    PetscInitialize(&argc,&args,(char *)0,help); 
    ierr = PetscOptionsGetInt(PETSC_NULL,"-m",&m,PETSC_NULL);CHKERRQ(ierr); 
    ierr = PetscOptionsGetInt(PETSC_NULL,"-n",&n,PETSC_NULL);CHKERRQ(ierr); 
    /* - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - 
     Compute the matrix and right-hand-side vector that define 
     the linear system, Ax = b. 
    - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - */ 
    /* 
    Create parallel matrix, specifying only its global dimensions. 
    When using MatCreate(), the matrix format can be specified at 
    runtime. Also, the parallel partitioning of the matrix is 
    determined by PETSc at runtime. 

    Performance tuning note: For problems of substantial size, 
    preallocation of matrix memory is crucial for attaining good 
    performance. See the matrix chapter of the users manual for details. 
    */ 
    ierr = MatCreate(PETSC_COMM_WORLD,&A);CHKERRQ(ierr); 
    ierr = MatSetSizes(A,PETSC_DECIDE,PETSC_DECIDE,m*n,m*n);CHKERRQ(ierr); 
    ierr = MatSetFromOptions(A);CHKERRQ(ierr); 
    ierr = MatMPIAIJSetPreallocation(A,5,PETSC_NULL,5,PETSC_NULL);CHKERRQ(ierr); 
    ierr = MatSeqAIJSetPreallocation(A,5,PETSC_NULL);CHKERRQ(ierr); 

    /* 
    Currently, all PETSc parallel matrix formats are partitioned by 
    contiguous chunks of rows across the processors. Determine which 
    rows of the matrix are locally owned. 
    */ 
    ierr = MatGetOwnershipRange(A,&Istart,&Iend);CHKERRQ(ierr); 

    /* 
    Set matrix elements for the 2-D, five-point stencil in parallel. 
     - Each processor needs to insert only elements that it owns 
     locally (but any non-local elements will be sent to the 
     appropriate processor during matrix assembly). 
     - Always specify global rows and columns of matrix entries. 

    Note: this uses the less common natural ordering that orders first 
    all the unknowns for x = h then for x = 2h etc; Hence you see J = Ii +- n 
    instead of J = I +- m as you might expect. The more standard ordering 
    would first do all variables for y = h, then y = 2h etc. 

    */ 
    ierr = PetscLogStageRegister("Assembly", &stage);CHKERRQ(ierr); 
    ierr = PetscLogStagePush(stage);CHKERRQ(ierr); 
    for (Ii=Istart; Ii<Iend; Ii++) { 
    v = -1.0; i = Ii/n; j = Ii - i*n; 
    if (i>0) {J = Ii - n; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr);} 
    if (i<m-1) {J = Ii + n; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr);} 
    if (j>0) {J = Ii - 1; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr);} 
    if (j<n-1) {J = Ii + 1; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr);} 
    v = 4.0; ierr = MatSetValues(A,1,&Ii,1,&Ii,&v,INSERT_VALUES);CHKERRQ(ierr); 
    } 

    /* 
    Assemble matrix, using the 2-step process: 
     MatAssemblyBegin(), MatAssemblyEnd() 
    Computations can be done while messages are in transition 
    by placing code between these two statements. 
    */ 
    ierr = MatAssemblyBegin(A,MAT_FINAL_ASSEMBLY);CHKERRQ(ierr); 
    ierr = MatAssemblyEnd(A,MAT_FINAL_ASSEMBLY);CHKERRQ(ierr); 
    ierr = PetscLogStagePop();CHKERRQ(ierr); 

    /* A is symmetric. Set symmetric flag to enable ICC/Cholesky preconditioner */ 
    ierr = MatSetOption(A,MAT_SYMMETRIC,PETSC_TRUE);CHKERRQ(ierr); 

    /* 
    Create parallel vectors. 
     - We form 1 vector from scratch and then duplicate as needed. 
     - When using VecCreate(), VecSetSizes and VecSetFromOptions() 
     in this example, we specify only the 
     vector's global dimension; the parallel partitioning is determined 
     at runtime. 
     - When solving a linear system, the vectors and matrices MUST 
     be partitioned accordingly. PETSc automatically generates 
     appropriately partitioned matrices and vectors when MatCreate() 
     and VecCreate() are used with the same communicator. 
     - The user can alternatively specify the local vector and matrix 
     dimensions when more sophisticated partitioning is needed 
     (replacing the PETSC_DECIDE argument in the VecSetSizes() statement 
     below). 
    */ 
    ierr = VecCreate(PETSC_COMM_WORLD,&u);CHKERRQ(ierr); 
    ierr = VecSetSizes(u,PETSC_DECIDE,m*n);CHKERRQ(ierr); 
    ierr = VecSetFromOptions(u);CHKERRQ(ierr); 
    ierr = VecDuplicate(u,&b);CHKERRQ(ierr); 
    ierr = VecDuplicate(b,&x);CHKERRQ(ierr); 

    /* 
    Set exact solution; then compute right-hand-side vector. 
    By default we use an exact solution of a vector with all 
    elements of 1.0; Alternatively, using the runtime option 
    -random_sol forms a solution vector with random components. 
    */ 
    ierr = PetscOptionsGetBool(PETSC_NULL,"-random_exact_sol",&flg,PETSC_NULL);CHKERRQ(ierr); 
    if (flg) { 
    ierr = PetscRandomCreate(PETSC_COMM_WORLD,&rctx);CHKERRQ(ierr); 
    ierr = PetscRandomSetFromOptions(rctx);CHKERRQ(ierr); 
    ierr = VecSetRandom(u,rctx);CHKERRQ(ierr); 
    ierr = PetscRandomDestroy(&rctx);CHKERRQ(ierr); 
    } else { 
    ierr = VecSet(u,1.0);CHKERRQ(ierr); 
    } 
    ierr = MatMult(A,u,b);CHKERRQ(ierr); 

    /* 
    View the exact solution vector if desired 
    */ 
    flg = PETSC_FALSE; 
    ierr = PetscOptionsGetBool(PETSC_NULL,"-view_exact_sol",&flg,PETSC_NULL);CHKERRQ(ierr); 
    if (flg) {ierr = VecView(u,PETSC_VIEWER_STDOUT_WORLD);CHKERRQ(ierr);} 

    /* - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - 
       Create the linear solver and set various options 
    - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - */ 

    /* 
    Create linear solver context 
    */ 
    ierr = KSPCreate(PETSC_COMM_WORLD,&ksp);CHKERRQ(ierr); 

    /* 
    Set operators. Here the matrix that defines the linear system 
    also serves as the preconditioning matrix. 
    */ 
    ierr = KSPSetOperators(ksp,A,A,DIFFERENT_NONZERO_PATTERN);CHKERRQ(ierr); 

    /* 
    Set linear solver defaults for this problem (optional). 
    - By extracting the KSP and PC contexts from the KSP context, 
     we can then directly call any KSP and PC routines to set 
     various options. 
    - The following two statements are optional; all of these 
     parameters could alternatively be specified at runtime via 
     KSPSetFromOptions(). All of these defaults can be 
     overridden at runtime, as indicated below. 
    */ 
    ierr = KSPSetTolerances(ksp,1.e-2/((m+1)*(n+1)),1.e-50,PETSC_DEFAULT, 
          PETSC_DEFAULT);CHKERRQ(ierr); 

    /* 
    Set runtime options, e.g., 
     -ksp_type <type> -pc_type <type> -ksp_monitor -ksp_rtol <rtol> 
    These options will override those specified above as long as 
    KSPSetFromOptions() is called _after_ any other customization 
    routines. 
    */ 
    ierr = KSPSetFromOptions(ksp);CHKERRQ(ierr); 

    /* - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - 
         Solve the linear system 
    - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - */ 

    ierr = KSPSolve(ksp,b,x);CHKERRQ(ierr); 

    /* - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - 
         Check solution and clean up 
    - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - */ 

    /* 
    Check the error 
    */ 
    ierr = VecAXPY(x,-1.0,u);CHKERRQ(ierr); 
    ierr = VecNorm(x,NORM_2,&norm);CHKERRQ(ierr); 
    ierr = KSPGetIterationNumber(ksp,&its);CHKERRQ(ierr); 
    /* Scale the norm */ 
    /* norm *= sqrt(1.0/((m+1)*(n+1))); */ 

    /* 
    Print convergence information. PetscPrintf() produces a single 
    print statement from all processes that share a communicator. 
    An alternative is PetscFPrintf(), which prints to a file. 
    */ 
    ierr = PetscPrintf(PETSC_COMM_WORLD,"Norm of error %A iterations %D\n", 
        norm,its);CHKERRQ(ierr); 

    /* 
    Free work space. All PETSc objects should be destroyed when they 
    are no longer needed. 
    */ 
    ierr = KSPDestroy(&ksp);CHKERRQ(ierr); 
    ierr = VecDestroy(&u);CHKERRQ(ierr); ierr = VecDestroy(&x);CHKERRQ(ierr); 
    ierr = VecDestroy(&b);CHKERRQ(ierr); ierr = MatDestroy(&A);CHKERRQ(ierr); 

    /* 
    Always call PetscFinalize() before exiting a program. This routine 
     - finalizes the PETSc libraries as well as MPI 
     - provides summary and diagnostic information if certain runtime 
     options are chosen (e.g., -log_summary). 
    */ 
    ierr = PetscFinalize(); 
    return 0; 
} 

誰かが例の中に自分の行列を埋める方法を知っていますか?

答えて

11

ええ、これは、あなたが始めているときに少し難しいことがあります。 2006年からチュートリアルthisACTSのプロセスの良いウォークスルーがあります。 PetSCのWebページのtutorials listedは一般的にはかなり良いです。この

重要な部分である:

ierr = MatCreate(PETSC_COMM_WORLD,&A);CHKERRQ(ierr); 

実際PetSCマトリックスオブジェクト、Mat Aを作成します。

ierr = MatSetSizes(A,PETSC_DECIDE,PETSC_DECIDE,m*n,m*n);CHKERRQ(ierr); 

サイズを設定します。それはこれがちょうどあなた場合は、実行時に供給し、マトリックスに適用している可能性のあるPetSCコマンドラインオプションを取るm x n 2Dグリッド上

ierr = MatSetFromOptions(A);CHKERRQ(ierr); 

を操作するためのステンシルだとして、ここで、行列は、m*n x m*nですAがどのように設定されたかを制御したい。そうでなければ、例えば、MatCreateMPIAIJ()を使用して、それが密な行列になる場合は、AIJ形式の行列(デフォルト)、MatCreateMPIDense()として作成することができます。

ierr = MatMPIAIJSetPreallocation(A,5,PETSC_NULL,5,PETSC_NULL);CHKERRQ(ierr); 
    ierr = MatSeqAIJSetPreallocation(A,5,PETSC_NULL);CHKERRQ(ierr); 

今、私たちはAIJ行列を得ていることを、これらの呼び出しは単なる行当たり5非ゼロと仮定すると、スパース行列を事前に割り当てます。これはパフォーマンスのためです。 MPI関数とSeq関数の両方を呼び出して、1つのプロセッサと複数のプロセッサで動作することを確認する必要があります。これはいつも変わったように見えましたが、あなたはそこに行きます。

ここで、マトリックスがすべて設定されたので、ここで実際の肉の肉に入ることにします。

まず、この特定のプロセスがどの行を所有しているかを調べます。分布は行によるものであり、これは典型的な疎マトリックスの良好な分布である。あなたはループのために、この中で見るよう

ierr = MatGetOwnershipRange(A,&Istart,&Iend);CHKERRQ(ierr); 

だから、この呼び出しの後、各プロセッサは、ちょうど IEND前を終了ISTARTの終わりから始まる行を更新するISTARTとIEND、およびその本プロセッサジョブの独自のバージョンがあります:

for (Ii=Istart; Ii<Iend; Ii++) { 
    v = -1.0; i = Ii/n; j = Ii - i*n; 

[OK]を、私たちは行Ii上で動作している場合、これは(i,j)i = Ii/nj = Ii % nグリッド位置に対応します。例えば、グリッド位置(i,j)は行Ii = i*n + jに対応します。意味がありますか?

if文は重要なのでここでは除外しますが、境界値を扱うだけなので、複雑になります。この行の

、に対応する列で対角、及び-1,2に+4、(i+1,j)(i,j-1)、及び(i,j+1)が存在するであろう。私たちはこれらのためのグリッド(例えば、1 < i < m-11 < j < n-1)の末尾から行っていないと仮定すると、それが意味

J = Ii - n; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr); 
    J = Ii + n; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr); 
    J = Ii - 1; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr); 
    J = Ii + 1; ierr = MatSetValues(A,1,&Ii,1,&J,&v,INSERT_VALUES);CHKERRQ(ierr); 

    v = 4.0; ierr = MatSetValues(A,1,&Ii,1,&Ii,&v,INSERT_VALUES);CHKERRQ(ierr); 
    } 

ザ・私はちょうど彼らが存在しない場合は、それらの値を設定しないように取り出したif文、 CHKERRQマクロは、ierr != 0のような有用なエラーを出力します。たとえば、設定値が失敗した(無効な値を設定しようとしたため)。

ここではローカル値を設定しました。 MatAssemblyは、プロセッサ間で必要な値が交換されるように通信を開始します。

ierr = MatAssemblyBegin(A,MAT_FINAL_ASSEMBLY);CHKERRQ(ierr); 
    ierr = MatAssemblyEnd(A,MAT_FINAL_ASSEMBLY);CHKERRQ(ierr); 

そして今、あなたが行われていると、あなたのソルバーを呼び出すことができます。あなたが行うには関係のない仕事を持っている場合は、それが開始し、通信と計算をオーバーラップするようにしようとする端部との間に貼り付けることができます。

だから典型的なワークフローは次のとおりです。

  • あなたのマトリックスを作成します(MatCreate
  • 設定し、そのサイズ(MatSetSizes
  • 設定し、さまざまな行列のオプション(MatSetFromOptionsではなく、物事をハードコーディングするよりも、良い選択です)
  • スパース行列の場合は、行ごとに非ゼロの数を妥当に推測するよう事前割り当てを設定します。 (で埋められています),MatSeqAIJSetPreallocation
  • あなたの責任である行を見つけてください:ここでは、単一の値(ここのように)または行ごとの非ゼロの数を表す配列
  • そしてアセンブリ(MatAssemblyBeginMatAssemblyEnd)を行う;(MatGetOwnershipRange
  • 、値(INSERT_VALUESセットの新しい要素、ADD_VALUES増分既存の要素の値ごとに一度、または値のチャンクに通過いずれかMatSetValuesを呼び出す)がセット。

さらに複雑な使用例があります。

+0

これはさらに票が必要です – pyCthon

関連する問題