Implemented Function pointer for SOR, RB and RBA variants
This commit is contained in:
		@@ -31,9 +31,9 @@ p_init        0.0      # initial value for pressure
 | 
			
		||||
xlength       30.0     # domain size in x-direction
 | 
			
		||||
ylength       4.0	   # domain size in y-direction
 | 
			
		||||
zlength       4.0	   # domain size in z-direction
 | 
			
		||||
imax          200      # number of interior cells in x-direction
 | 
			
		||||
jmax          50	   # number of interior cells in y-direction
 | 
			
		||||
kmax          50	   # number of interior cells in z-direction
 | 
			
		||||
imax          40      # number of interior cells in x-direction
 | 
			
		||||
jmax          10	   # number of interior cells in y-direction
 | 
			
		||||
kmax          10	   # number of interior cells in z-direction
 | 
			
		||||
 | 
			
		||||
# Time Data:
 | 
			
		||||
# ---------
 | 
			
		||||
@@ -47,6 +47,7 @@ tau      0.5     # safety factor for time stepsize control (<0 constant delt)
 | 
			
		||||
 | 
			
		||||
itermax       500       # maximal number of pressure iteration in one time step
 | 
			
		||||
eps           0.0001   # stopping tolerance for pressure iteration
 | 
			
		||||
rho           0.52
 | 
			
		||||
omg           1.3       # relaxation parameter for SOR iteration
 | 
			
		||||
gamma         0.9       # upwind differencing factor gamma
 | 
			
		||||
#===============================================================================
 | 
			
		||||
 
 | 
			
		||||
@@ -1,5 +1,5 @@
 | 
			
		||||
# Supported: GCC, CLANG, ICC
 | 
			
		||||
TAG ?= ICC
 | 
			
		||||
TAG ?= CLANG
 | 
			
		||||
ENABLE_OPENMP ?= false
 | 
			
		||||
 | 
			
		||||
#Feature options
 | 
			
		||||
 
 | 
			
		||||
							
								
								
									
										
											BIN
										
									
								
								BasicSolver/3D-mpi-io/dcavity-p4.vtk
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										
											BIN
										
									
								
								BasicSolver/3D-mpi-io/dcavity-p4.vtk
									
									
									
									
									
										Normal file
									
								
							
										
											Binary file not shown.
										
									
								
							@@ -31,9 +31,9 @@ p_init    0.0		# initial value for pressure
 | 
			
		||||
xlength    1.0		# domain size in x-direction
 | 
			
		||||
ylength    1.0		# domain size in y-direction
 | 
			
		||||
zlength    1.0		# domain size in z-direction
 | 
			
		||||
imax       128		# number of interior cells in x-direction
 | 
			
		||||
jmax       128		# number of interior cells in y-direction
 | 
			
		||||
kmax       128		# number of interior cells in z-direction
 | 
			
		||||
imax       40		# number of interior cells in x-direction
 | 
			
		||||
jmax       40		# number of interior cells in y-direction
 | 
			
		||||
kmax       40		# number of interior cells in z-direction
 | 
			
		||||
 | 
			
		||||
# Time Data:
 | 
			
		||||
# ---------
 | 
			
		||||
@@ -47,6 +47,7 @@ tau      0.5		# safety factor for time stepsize control (<0 constant delt)
 | 
			
		||||
 | 
			
		||||
itermax  1000		# maximal number of pressure iteration in one time step
 | 
			
		||||
eps      0.001		# stopping tolerance for pressure iteration
 | 
			
		||||
rho      0.5
 | 
			
		||||
omg      1.8		# relaxation parameter for SOR iteration
 | 
			
		||||
gamma    0.9		# upwind differencing factor gamma
 | 
			
		||||
#===============================================================================
 | 
			
		||||
 
 | 
			
		||||
@@ -19,9 +19,15 @@
 | 
			
		||||
#include "timing.h"
 | 
			
		||||
#include "vtkWriter.h"
 | 
			
		||||
 | 
			
		||||
enum VARIANT { SOR = 1, RB, RBA };
 | 
			
		||||
 | 
			
		||||
 | 
			
		||||
int main(int argc, char** argv)
 | 
			
		||||
{
 | 
			
		||||
 | 
			
		||||
    int variant = RB;
 | 
			
		||||
    int rank;
 | 
			
		||||
 | 
			
		||||
    double timeStart, timeStop;
 | 
			
		||||
    Parameter params;
 | 
			
		||||
    Solver solver;
 | 
			
		||||
@@ -30,12 +36,21 @@ int main(int argc, char** argv)
 | 
			
		||||
    MPI_Comm_rank(MPI_COMM_WORLD, &rank);
 | 
			
		||||
    initParameter(¶ms);
 | 
			
		||||
 | 
			
		||||
    if (argc != 2) {
 | 
			
		||||
    if (argc < 2) {
 | 
			
		||||
        printf("Usage: %s <configFile>\n", argv[0]);
 | 
			
		||||
        exit(EXIT_SUCCESS);
 | 
			
		||||
    }
 | 
			
		||||
 | 
			
		||||
    readParameter(¶ms, argv[1]);
 | 
			
		||||
 | 
			
		||||
    if (argc == 3) 
 | 
			
		||||
    {
 | 
			
		||||
        variant = atoi(argv[2]);
 | 
			
		||||
    }
 | 
			
		||||
 | 
			
		||||
    void (*solver_generic[])(solver) = {solve, solveRB, solveRBA};
 | 
			
		||||
 | 
			
		||||
 | 
			
		||||
    if (commIsMaster(&solver.comm)) {
 | 
			
		||||
        printParameter(¶ms);
 | 
			
		||||
    }
 | 
			
		||||
@@ -57,7 +72,7 @@ int main(int argc, char** argv)
 | 
			
		||||
        computeFG(&solver);
 | 
			
		||||
        computeRHS(&solver);
 | 
			
		||||
        // if (nt % 100 == 0) normalizePressure(&solver);
 | 
			
		||||
        solve(&solver);
 | 
			
		||||
        (*solver_generic[variant - 1])(&solver);
 | 
			
		||||
        adaptUV(&solver);
 | 
			
		||||
        t += solver.dt;
 | 
			
		||||
        nt++;
 | 
			
		||||
 
 | 
			
		||||
@@ -26,6 +26,7 @@ void initParameter(Parameter* param)
 | 
			
		||||
    param->re      = 100.0;
 | 
			
		||||
    param->gamma   = 0.9;
 | 
			
		||||
    param->tau     = 0.5;
 | 
			
		||||
    param->rho     = 0.99;
 | 
			
		||||
}
 | 
			
		||||
 | 
			
		||||
void readParameter(Parameter* param, const char* filename)
 | 
			
		||||
@@ -86,6 +87,8 @@ void readParameter(Parameter* param, const char* filename)
 | 
			
		||||
            PARSE_REAL(v_init);
 | 
			
		||||
            PARSE_REAL(w_init);
 | 
			
		||||
            PARSE_REAL(p_init);
 | 
			
		||||
            PARSE_REAL(rho);
 | 
			
		||||
 | 
			
		||||
        }
 | 
			
		||||
    }
 | 
			
		||||
 | 
			
		||||
 
 | 
			
		||||
@@ -11,7 +11,7 @@ typedef struct {
 | 
			
		||||
    int imax, jmax, kmax;
 | 
			
		||||
    double xlength, ylength, zlength;
 | 
			
		||||
    int itermax;
 | 
			
		||||
    double eps, omg;
 | 
			
		||||
    double eps, omg, rho;
 | 
			
		||||
    double re, tau, gamma;
 | 
			
		||||
    double te, dt;
 | 
			
		||||
    double gx, gy, gz;
 | 
			
		||||
 
 | 
			
		||||
@@ -103,6 +103,8 @@ void initSolver(Solver* s, Parameter* params)
 | 
			
		||||
    s->te      = params->te;
 | 
			
		||||
    s->tau     = params->tau;
 | 
			
		||||
    s->gamma   = params->gamma;
 | 
			
		||||
    s->rho     = params->rho;
 | 
			
		||||
 | 
			
		||||
 | 
			
		||||
    commInit(&s->comm, s->grid.kmax, s->grid.jmax, s->grid.imax);
 | 
			
		||||
    /* allocate arrays */
 | 
			
		||||
@@ -288,6 +290,267 @@ void solve(Solver* s)
 | 
			
		||||
#endif
 | 
			
		||||
}
 | 
			
		||||
 | 
			
		||||
void solveRB(Solver* s)
 | 
			
		||||
{
 | 
			
		||||
    int imaxLocal = s->comm.imaxLocal;
 | 
			
		||||
    int jmaxLocal = s->comm.jmaxLocal;
 | 
			
		||||
    int kmaxLocal = s->comm.kmaxLocal;
 | 
			
		||||
 | 
			
		||||
    int imax = s->grid.imax;
 | 
			
		||||
    int jmax = s->grid.jmax;
 | 
			
		||||
    int kmax = s->grid.kmax;
 | 
			
		||||
 | 
			
		||||
    double eps  = s->eps;
 | 
			
		||||
    int itermax = s->itermax;
 | 
			
		||||
    double dx2  = s->grid.dx * s->grid.dx;
 | 
			
		||||
    double dy2  = s->grid.dy * s->grid.dy;
 | 
			
		||||
    double dz2  = s->grid.dz * s->grid.dz;
 | 
			
		||||
    double idx2 = 1.0 / dx2;
 | 
			
		||||
    double idy2 = 1.0 / dy2;
 | 
			
		||||
    double idz2 = 1.0 / dz2;
 | 
			
		||||
 | 
			
		||||
    double factor = s->omega * 0.5 * (dx2 * dy2 * dz2) /
 | 
			
		||||
                    (dy2 * dz2 + dx2 * dz2 + dx2 * dy2);
 | 
			
		||||
    double* p    = s->p;
 | 
			
		||||
    double* rhs  = s->rhs;
 | 
			
		||||
    double epssq = eps * eps;
 | 
			
		||||
    int it       = 0;
 | 
			
		||||
    double res   = 1.0;
 | 
			
		||||
 | 
			
		||||
    int pass, ksw, jsw, isw;
 | 
			
		||||
 | 
			
		||||
 | 
			
		||||
    while ((res >= epssq) && (it < itermax)) {
 | 
			
		||||
        res = 0.0;
 | 
			
		||||
        ksw = 1;
 | 
			
		||||
 | 
			
		||||
        for (pass = 0; pass < 2; pass++) {
 | 
			
		||||
            jsw = ksw;
 | 
			
		||||
            commExchange(&s->comm, p);
 | 
			
		||||
 | 
			
		||||
 | 
			
		||||
            for (int k = 1; k < kmaxLocal + 1; k++) {
 | 
			
		||||
                isw = jsw;
 | 
			
		||||
                for (int j = 1; j < jmaxLocal + 1; j++) {
 | 
			
		||||
                    for (int i = isw; i < imaxLocal + 1; i += 2) {
 | 
			
		||||
 | 
			
		||||
                        double r =
 | 
			
		||||
                            RHS(i, j, k) -
 | 
			
		||||
                            ((P(i + 1, j, k) - 2.0 * P(i, j, k) + P(i - 1, j, k)) * idx2 +
 | 
			
		||||
                                (P(i, j + 1, k) - 2.0 * P(i, j, k) + P(i, j - 1, k)) *
 | 
			
		||||
                                    idy2 +
 | 
			
		||||
                                (P(i, j, k + 1) - 2.0 * P(i, j, k) + P(i, j, k - 1)) *
 | 
			
		||||
                                    idz2);
 | 
			
		||||
 | 
			
		||||
                        P(i, j, k) -= (factor * r);
 | 
			
		||||
                        res += (r * r);
 | 
			
		||||
                    }
 | 
			
		||||
                    isw = 3 - isw;
 | 
			
		||||
                }
 | 
			
		||||
                jsw = 3 - jsw;
 | 
			
		||||
            }
 | 
			
		||||
            ksw = 3 - ksw;
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, FRONT)) {
 | 
			
		||||
            for (int j = 1; j < jmaxLocal + 1; j++) {
 | 
			
		||||
                for (int i = 1; i < imaxLocal + 1; i++) {
 | 
			
		||||
                    P(i, j, 0) = P(i, j, 1);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, BACK)) {
 | 
			
		||||
            for (int j = 1; j < jmaxLocal + 1; j++) {
 | 
			
		||||
                for (int i = 1; i < imaxLocal + 1; i++) {
 | 
			
		||||
                    P(i, j, kmaxLocal + 1) = P(i, j, kmaxLocal);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, BOTTOM)) {
 | 
			
		||||
            for (int k = 1; k < kmaxLocal + 1; k++) {
 | 
			
		||||
                for (int i = 1; i < imaxLocal + 1; i++) {
 | 
			
		||||
                    P(i, 0, k) = P(i, 1, k);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, TOP)) {
 | 
			
		||||
            for (int k = 1; k < kmaxLocal + 1; k++) {
 | 
			
		||||
                for (int i = 1; i < imaxLocal + 1; i++) {
 | 
			
		||||
                    P(i, jmaxLocal + 1, k) = P(i, jmaxLocal, k);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, LEFT)) {
 | 
			
		||||
            for (int k = 1; k < kmaxLocal + 1; k++) {
 | 
			
		||||
                for (int j = 1; j < jmaxLocal + 1; j++) {
 | 
			
		||||
                    P(0, j, k) = P(1, j, k);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, RIGHT)) {
 | 
			
		||||
            for (int k = 1; k < kmaxLocal + 1; k++) {
 | 
			
		||||
                for (int j = 1; j < jmaxLocal + 1; j++) {
 | 
			
		||||
                    P(imaxLocal + 1, j, k) = P(imaxLocal, j, k);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        commReduction(&res, SUM);
 | 
			
		||||
        res = res / (double)(imax * jmax * kmax);
 | 
			
		||||
#ifdef DEBUG
 | 
			
		||||
        if (commIsMaster(&s->comm)) {
 | 
			
		||||
            printf("%d Residuum: %e\n", it, res);
 | 
			
		||||
        }
 | 
			
		||||
#endif
 | 
			
		||||
        //commExchange(&s->comm, p);
 | 
			
		||||
        it++;
 | 
			
		||||
    }
 | 
			
		||||
 | 
			
		||||
#ifdef VERBOSE
 | 
			
		||||
    if (commIsMaster(&s->comm)) {
 | 
			
		||||
        printf("Solver took %d iterations to reach %f\n", it, sqrt(res));
 | 
			
		||||
    }
 | 
			
		||||
#endif
 | 
			
		||||
}
 | 
			
		||||
 | 
			
		||||
 | 
			
		||||
void solveRBA(Solver* s)
 | 
			
		||||
{
 | 
			
		||||
    int imaxLocal = s->comm.imaxLocal;
 | 
			
		||||
    int jmaxLocal = s->comm.jmaxLocal;
 | 
			
		||||
    int kmaxLocal = s->comm.kmaxLocal;
 | 
			
		||||
 | 
			
		||||
    int imax = s->grid.imax;
 | 
			
		||||
    int jmax = s->grid.jmax;
 | 
			
		||||
    int kmax = s->grid.kmax;
 | 
			
		||||
 | 
			
		||||
    double eps  = s->eps;
 | 
			
		||||
    int itermax = s->itermax;
 | 
			
		||||
    double dx2  = s->grid.dx * s->grid.dx;
 | 
			
		||||
    double dy2  = s->grid.dy * s->grid.dy;
 | 
			
		||||
    double dz2  = s->grid.dz * s->grid.dz;
 | 
			
		||||
    double idx2 = 1.0 / dx2;
 | 
			
		||||
    double idy2 = 1.0 / dy2;
 | 
			
		||||
    double idz2 = 1.0 / dz2;
 | 
			
		||||
 | 
			
		||||
    double factor = 0.5 * (dx2 * dy2 * dz2) /
 | 
			
		||||
                    (dy2 * dz2 + dx2 * dz2 + dx2 * dy2);
 | 
			
		||||
    double* p    = s->p;
 | 
			
		||||
    double* rhs  = s->rhs;
 | 
			
		||||
    double epssq = eps * eps;
 | 
			
		||||
    int it       = 0;
 | 
			
		||||
    double res   = 1.0;
 | 
			
		||||
    double rho    = s->rho;
 | 
			
		||||
    double omega  = 1.0;
 | 
			
		||||
 | 
			
		||||
    int pass, ksw, jsw, isw;
 | 
			
		||||
 | 
			
		||||
    while ((res >= epssq) && (it < itermax)) {
 | 
			
		||||
        res = 0.0;
 | 
			
		||||
        ksw = 1;
 | 
			
		||||
 | 
			
		||||
        for (pass = 0; pass < 2; pass++) {
 | 
			
		||||
            jsw = ksw;
 | 
			
		||||
            commExchange(&s->comm, p);
 | 
			
		||||
 | 
			
		||||
 | 
			
		||||
            for (int k = 1; k < kmaxLocal + 1; k++) {
 | 
			
		||||
                isw = jsw;
 | 
			
		||||
                for (int j = 1; j < jmaxLocal + 1; j++) {
 | 
			
		||||
                    for (int i = isw; i < imaxLocal + 1; i += 2) {
 | 
			
		||||
 | 
			
		||||
                        double r =
 | 
			
		||||
                            RHS(i, j, k) -
 | 
			
		||||
                            ((P(i + 1, j, k) - 2.0 * P(i, j, k) + P(i - 1, j, k)) * idx2 +
 | 
			
		||||
                                (P(i, j + 1, k) - 2.0 * P(i, j, k) + P(i, j - 1, k)) *
 | 
			
		||||
                                    idy2 +
 | 
			
		||||
                                (P(i, j, k + 1) - 2.0 * P(i, j, k) + P(i, j, k - 1)) *
 | 
			
		||||
                                    idz2);
 | 
			
		||||
 | 
			
		||||
                        P(i, j, k) -= (omega * factor * r);
 | 
			
		||||
                        res += (r * r);
 | 
			
		||||
                    }
 | 
			
		||||
                    isw = 3 - isw;
 | 
			
		||||
                }
 | 
			
		||||
                jsw = 3 - jsw;
 | 
			
		||||
            }
 | 
			
		||||
            ksw = 3 - ksw;
 | 
			
		||||
            omega = (it == 0 && pass == 0 ? 1.0 / (1.0 - 0.5 * rho * rho)
 | 
			
		||||
                                          : 1.0 / (1.0 - 0.25 * rho * rho * omega));
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, FRONT)) {
 | 
			
		||||
            for (int j = 1; j < jmaxLocal + 1; j++) {
 | 
			
		||||
                for (int i = 1; i < imaxLocal + 1; i++) {
 | 
			
		||||
                    P(i, j, 0) = P(i, j, 1);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, BACK)) {
 | 
			
		||||
            for (int j = 1; j < jmaxLocal + 1; j++) {
 | 
			
		||||
                for (int i = 1; i < imaxLocal + 1; i++) {
 | 
			
		||||
                    P(i, j, kmaxLocal + 1) = P(i, j, kmaxLocal);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, BOTTOM)) {
 | 
			
		||||
            for (int k = 1; k < kmaxLocal + 1; k++) {
 | 
			
		||||
                for (int i = 1; i < imaxLocal + 1; i++) {
 | 
			
		||||
                    P(i, 0, k) = P(i, 1, k);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, TOP)) {
 | 
			
		||||
            for (int k = 1; k < kmaxLocal + 1; k++) {
 | 
			
		||||
                for (int i = 1; i < imaxLocal + 1; i++) {
 | 
			
		||||
                    P(i, jmaxLocal + 1, k) = P(i, jmaxLocal, k);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, LEFT)) {
 | 
			
		||||
            for (int k = 1; k < kmaxLocal + 1; k++) {
 | 
			
		||||
                for (int j = 1; j < jmaxLocal + 1; j++) {
 | 
			
		||||
                    P(0, j, k) = P(1, j, k);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        if (commIsBoundary(&s->comm, RIGHT)) {
 | 
			
		||||
            for (int k = 1; k < kmaxLocal + 1; k++) {
 | 
			
		||||
                for (int j = 1; j < jmaxLocal + 1; j++) {
 | 
			
		||||
                    P(imaxLocal + 1, j, k) = P(imaxLocal, j, k);
 | 
			
		||||
                }
 | 
			
		||||
            }
 | 
			
		||||
        }
 | 
			
		||||
 | 
			
		||||
        commReduction(&res, SUM);
 | 
			
		||||
        res = res / (double)(imax * jmax * kmax);
 | 
			
		||||
#ifdef DEBUG
 | 
			
		||||
        if (commIsMaster(&s->comm)) {
 | 
			
		||||
            printf("%d Residuum: %e\n", it, res);
 | 
			
		||||
        }
 | 
			
		||||
#endif
 | 
			
		||||
        //commExchange(&s->comm, p);
 | 
			
		||||
        it++;
 | 
			
		||||
    }
 | 
			
		||||
 | 
			
		||||
#ifdef VERBOSE
 | 
			
		||||
    if (commIsMaster(&s->comm)) {
 | 
			
		||||
        printf("Solver took %d iterations to reach %f\n", it, sqrt(res));
 | 
			
		||||
    }
 | 
			
		||||
#endif
 | 
			
		||||
}
 | 
			
		||||
 | 
			
		||||
 | 
			
		||||
static double maxElement(Solver* s, double* m)
 | 
			
		||||
{
 | 
			
		||||
    int size = (s->comm.imaxLocal + 2) * (s->comm.jmaxLocal + 2) *
 | 
			
		||||
 
 | 
			
		||||
@@ -20,7 +20,7 @@ typedef struct {
 | 
			
		||||
    double *f, *g, *h;
 | 
			
		||||
    double *u, *v, *w;
 | 
			
		||||
    /* parameters */
 | 
			
		||||
    double eps, omega;
 | 
			
		||||
    double eps, omega, rho;
 | 
			
		||||
    double re, tau, gamma;
 | 
			
		||||
    double gx, gy, gz;
 | 
			
		||||
    /* time stepping */
 | 
			
		||||
@@ -36,6 +36,8 @@ typedef struct {
 | 
			
		||||
void initSolver(Solver*, Parameter*);
 | 
			
		||||
void computeRHS(Solver*);
 | 
			
		||||
void solve(Solver*);
 | 
			
		||||
void solveRB(Solver*);
 | 
			
		||||
void solveRBA(Solver*);
 | 
			
		||||
void normalizePressure(Solver*);
 | 
			
		||||
void computeTimestep(Solver*);
 | 
			
		||||
void setBoundaryConditions(Solver*);
 | 
			
		||||
 
 | 
			
		||||
		Reference in New Issue
	
	Block a user