Ejemplo n.º 1
0
// Sets only flowDir only where there is a positive slope
// Returns number of cells which are flat
int setPosDir(linearpart<float>& elevDEM, linearpart<short>& flowDir)
{
    double dxA = elevDEM.getdxA();
    double dyA = elevDEM.getdyA();
    int nx = elevDEM.getnx();
    int ny = elevDEM.getny();
    int numFlat = 0;

    double tempdxc, tempdyc;

    fact = new double*[ny]; // initialize 2d array by Nazmus 2/16

    for(int m = 0; m<ny; m++)
        fact[m] = new double[9];

    for (int m = 0; m<ny; m++) {
        for (int k = 1; k <= 8; k++) {
            elevDEM.getdxdyc(m, tempdxc, tempdyc);
            fact[m][k] = (double) (1./sqrt(d1[k]*d1[k]*tempdxc*tempdxc + d2[k]*d2[k]*tempdyc*tempdyc));
        }
    }

    for (int j = 0; j < ny; j++) {
        for (int i=0; i < nx; i++) {
            //FlowDir is nodata if it is on the border OR elevDEM has no data
            if (elevDEM.isNodata(i,j) || !elevDEM.hasAccess(i-1,j) || !elevDEM.hasAccess(i+1,j) ||
                    !elevDEM.hasAccess(i,j-1) || !elevDEM.hasAccess(i,j+1)) {
                //do nothing
                continue;
            }

            //Check if cell is "contaminated" (neighbors have no data)
            //  set flowDir to noData if contaminated
            bool contaminated = false;
            for (int k=1; k<=8; k++) {
                int in=i+d1[k];
                int jn=j+d2[k];

                if (elevDEM.isNodata(in,jn)) {
                    contaminated = true;
                    break;
                }
            }

            if (contaminated) {
                flowDir.setToNodata(i,j);
            } else {
                // If cell is not contaminated,
                flowDir.setData(i, j, 0);
                setFlow(i,j, flowDir, elevDEM);

                if (flowDir.getData(i,j) == 0) {
                    numFlat++;
                }
            }
        }
    }

    return numFlat;
}
long setPosDirDinf(linearpart<float>& elevDEM, linearpart<float>& flowDir, linearpart<float>& slope, int useflowfile) {
    double dxA = elevDEM.getdxA();
    double dyA = elevDEM.getdyA();
    long nx = elevDEM.getnx();
    long ny = elevDEM.getny();
    float tempFloat;
    double tempdxc, tempdyc;
    int i, j, k, in, jn, con;
    long numFlat = 0;

    tempFloat = 0;
    for (j = 0; j < ny; j++) {
        for (i = 0; i < nx; i++) {


            //FlowDir is nodata if it is on the border OR elevDEM has no data
            if (elevDEM.isNodata(i, j) || !elevDEM.hasAccess(i - 1, j) || !elevDEM.hasAccess(i + 1, j) ||
                    !elevDEM.hasAccess(i, j - 1) || !elevDEM.hasAccess(i, j + 1)) {
                //do nothing			
            } else {
                //Check if cell is "contaminated" (neighbors have no data)
                //  set flowDir to noData if contaminated
                con = 0;
                for (k = 1; k <= 8 && con != -1; k++) {
                    in = i + d1[k];
                    jn = j + d2[k];
                    if (elevDEM.isNodata(in, jn)) con = -1;
                }
                if (con == -1) 
                    flowDir.setToNodata(i, j);
                    //If cell is not contaminated,
                else {
                    tempFloat = -1.;
                    flowDir.setData(i, j, tempFloat); //set to -1
                    elevDEM.getdxdyc(j, tempdxc, tempdyc);


                    float DXX[3] = {0, tempdxc, tempdyc}; //tardemlib.cpp ln 1291
                    float DD = sqrt(tempdxc * tempdxc + tempdyc * tempdyc); //tardemlib.cpp ln 1293
                    SET2(j, i, DXX, DD, elevDEM, flowDir, slope); //i=y in function form old code j is x switched on purpose
                    //  Use SET2 from serial code here modified to get what it has as felevg.d from elevDEM partition
                    //  Modify to return 0 if there is a 0 slope.  Modify SET2 to output flowDIR as no data (do nothing 
                    //  if verified initialization to nodata) and 
                    //  slope as 0 if a positive slope is not found

                    //setFlow( i,j, flowDir, elevDEM, area, useflowfile);
                    if (flowDir.getData(i, j, tempFloat) == -1)
                        numFlat++;
                }
            }
        }
    }
    return numFlat;
}
Ejemplo n.º 3
0
//Set positive flowdirections of elevDEM
void setFlow(int i, int j, linearpart<short>& flowDir, linearpart<float>& elevDEM)
{
    int in,jn;
    int amax=0;
    float smax=0;

    float elev = elevDEM.getData(i, j);
    
    // fixme: return instead of checking isNodata

    for (short k=1; k<=8 && !flowDir.isNodata(i,j); k+=2) {
        in=i+d1[k];
        jn=j+d2[k];
        
        float slope = fact[j][k] * (elev - elevDEM.getData(in,jn));

        if (slope > smax) {
            smax=slope;
            short dirnb=flowDir.getData(in,jn);

            if (dirnb > 0 && abs(dirnb-k) == 4) {
                flowDir.setToNodata(i,j);
            } else {
                flowDir.setData(i,j,k);
            }
        }
    }

    for (short k=2; k<=8 && !flowDir.isNodata(i,j); k+=2) {
        in=i+d1[k];
        jn=j+d2[k];

        float slope = fact[j][k] * (elev - elevDEM.getData(in,jn));

        if (slope > smax && !cellsCross(k,i,j,flowDir)) {
            smax = slope;
            short dirnb = flowDir.getData(in,jn);

            if (dirnb > 0 && abs(dirnb-k) == 4) { 
                flowDir.setToNodata(i,j);
            } else {
                flowDir.setData(i,j,k);
            }
        }
    }
}
void flowTowardsLower(T& elev, linearpart<float>& flowDir, std::vector<std::vector<node>>&islands, SparsePartition<short>& inc) 
{
    long nx = flowDir.getnx();
    long ny = flowDir.getny();

    std::vector<node> lowBoundaries;

    // Find low boundaries. 
    for(auto& island : islands) {
        for(node flat : island) {
            float flatElev = elev.getData(flat.x, flat.y);

            for (int k = 1; k <= 8; k++) {
                if (dontCross(k, flat.x, flat.y, flowDir) == 0) {
                    int in = flat.x + d1[k];
                    int jn = flat.y + d2[k];

                    if (!flowDir.hasAccess(in, jn))
                        continue;

                    auto elevDiff = flatElev - elev.getData(in,jn);
                    float flow = flowDir.getData(in, jn);

                    bool edgeDrain = flowDir.isNodata(in, jn);

                    // Adjacent cell drains and is equal or lower in elevation so this is a low boundary
                    if ((elevDiff >= 0 && flow >= 0.0) || edgeDrain) {
                        lowBoundaries.push_back(flat);
                        inc.setData(flat.x, flat.y, -1);

                        // No need to check the other neighbors
                        break;
                    } 
                }
            }
        }
    }

    size_t numInc = propagateIncrements(flowDir, inc, lowBoundaries);

    // Not all grid cells were resolved - pits remain
    // Remaining grid cells are unresolvable pits
    if (numInc > 0)          
    {
        markPits(elev, flowDir, islands, inc);
    }
}
Ejemplo n.º 5
0
//Calculate the slope information of flowDir to slope
void calcSlope(linearpart<short>& flowDir, linearpart<float>& elevDEM, linearpart<float>& slope)
{
    int nx = elevDEM.getnx();
    int ny = elevDEM.getny();

    for (int j=0; j < ny; j++) {
        for (int i=0; i < nx; i++) {
            // If i,j is on the border or flowDir has no data, set slope(i,j) to slopeNoData
            if (flowDir.isNodata(i,j) || !flowDir.hasAccess(i-1,j) || !flowDir.hasAccess(i+1,j) ||
                    !flowDir.hasAccess(i,j-1) || !flowDir.hasAccess(i,j+1)) {
                slope.setToNodata(i, j);
            } else {
                short flowDirection = flowDir.getData(i,j);
  
                int in = i + d1[flowDirection];
                int jn = j + d2[flowDirection];

                float elevDiff = elevDEM.getData(i,j) - elevDEM.getData(in,jn);
                slope.setData(i,j, elevDiff*fact[j][flowDirection]);
            }
        }
    }
}
void SET2(int I, int J, float *DXX, float DD, T& elevDEM, SparsePartition<short>& elev2, linearpart<float>& flowDir) {
    float SK[9];
    float ANGLE[9];
    float SMAX = 0.0;
    float tempFloat;
    short tempShort, tempShort1, tempShort2;
    int K;
    int KD = 0;

    int ID1[] = {0, 1, 2, 2, 1, 1, 2, 2, 1};
    int ID2[] = {0, 2, 1, 1, 2, 2, 1, 1, 2};
    int I1[] = {0, 0, -1, -1, 0, 0, 1, 1, 0};
    int I2[] = {0, -1, -1, -1, -1, 1, 1, 1, 1};
    int J1[] = {0, 1, 0, 0, -1, -1, 0, 0, 1};
    int J2[] = {0, 1, 1, -1, -1, -1, -1, 1, 1};
    float ANGC[] = {0, 0., 1., 1., 2., 2., 3., 3., 4.};
    float ANGF[] = {0, 1., -1., 1., -1., 1., -1., 1., -1.};
    bool diagOutFound = false;  

    for (K = 1; K <= 8; K++) {
        tempShort1 = elev2.getData(J + J1[K], I + I1[K]);
        tempShort2 = elev2.getData(J + J2[K], I + I2[K]);
        
        if (tempShort1 <= 0 && tempShort2 <= 0) { //Both E1 and E2 are outside the flat get slope and angle
            float a = elevDEM.getData(J, I);
            float b = elevDEM.getData(J + J1[K], I + I1[K]);
            float c = elevDEM.getData(J + J2[K], I + I2[K]);
            VSLOPE(
                    a, //E0
                    b, //E1
                    c, //E2
                    DXX[ID1[K]], //dx or dy depending on ID1
                    DXX[ID2[K]], //dx or dy depending on ID2
                    DD, //Hypotenuse
                    &SK[K], //Slope Returned
                    &ANGLE[K]//Angle Returned
                    );
            if (SK[K] >= 0.0) //  Found an outlet
            {
                if (b > a) // Outlet found had better be a diagonal, because it is not an edge
                {
                    if (!diagOutFound) {
                        diagOutFound = true;
                        KD = K;
                    }
                } else { //  Here it is an adjacent outlet
                    KD = K;
                    break;
                }
            }

        } else if (tempShort1 <= 0 && tempShort2 > 0) {//E1 is outside of the flat and E2 is inside the flat. Use DEM elevations. tempShort2/E2 is in the artificial grid
            float a = elevDEM.getData(J, I);
            float b = elevDEM.getData(J + J1[K], I + I1[K]);

            if (a >= b) {
                ANGLE[K] = 0.0;
                SK[K] = 0.0;
                KD = K;
                break;
            }
            short a1 = elev2.getData(J, I);
            short c1 = elev2.getData(J + J2[K], I + I2[K]);
            short b1 = max(a1, c1);
            VSLOPE(
                    (float) a1, //felevg.d[J][I],
                    (float) b1, //[felevg.d[J+J1[K]][I+I1[K]],
                    (float) c1, //felevg.d[J+J2[K]][I+I2[K]],
                    DXX[ID1[K]], //dx or dy
                    DXX[ID2[K]], //dx or dy
                    DD, //Hypotenuse
                    &SK[K], //Slope Returned
                    &ANGLE[K]//Angle Reutnred
                    );
            if (SK[K] > SMAX) {
                SMAX = SK[K];
                KD = K;
            }
        } else if (tempShort1 > 0 && tempShort2 <= 0) {//E2 is out side of the flat and E1 is inside the flat, use DEM elevations
            float a = elevDEM.getData(J, I);
            //float b=elevDEM->getData(J+J1[K],I+I1[K],tempFloat);
            float c = elevDEM.getData(J + J2[K], I + I2[K]);
            if (a >= c) {
                if (!diagOutFound) {
                    ANGLE[K] = (float) atan2(DXX[ID2[K]], DXX[ID1[K]]);
                    SK[K] = 0.0;
                    KD = K;
                    diagOutFound = true;
                }
            } else {
                short a1 = elev2.getData(J, I);
                short b1 = elev2.getData(J + J1[K], I + I1[K]);
                short c1 = max(a1, b1);
                VSLOPE(
                        (float) a1, //felevg.d[J][I],
                        (float) b1, //[felevg.d[J+J1[K]][I+I1[K]],
                        (float) c1, //felevg.d[J+J2[K]][I+I2[K]],
                        DXX[ID1[K]], //dx or dy
                        DXX[ID2[K]], //dx or dy
                        DD, //Hypotenuse
                        &SK[K], //Slope Returned
                        &ANGLE[K]//Angle Reutnred
                        );
                if (SK[K] > SMAX) {
                    SMAX = SK[K];
                    KD = K;
                }

            }
        } else {//Both E1 and E2 are in the flat. Use artificial elevation to get slope and angle
            short a, b, c;
            a = elev2.getData(J, I);
            b = elev2.getData(J + J1[K], I + I1[K]);
            c = elev2.getData(J + J2[K], I + I2[K]);
            VSLOPE(
                    (float) a, //felevg.d[J][I],
                    (float) b, //[felevg.d[J+J1[K]][I+I1[K]],
                    (float) c, //felevg.d[J+J2[K]][I+I2[K]],
                    DXX[ID1[K]], //dx or dy
                    DXX[ID2[K]], //dx or dy
                    DD, //Hypotenuse
                    &SK[K], //Slope Returned
                    &ANGLE[K]//Angle Reutnred
                    );
            if (SK[K] > SMAX) {
                SMAX = SK[K];
                KD = K;
            }
        }
    }
    //USE -1 TO INDICATE DIRECTION NOT YET SET, 
    // but only for non pit grid cells.  Pits will have flowDir as no data
    if (!flowDir.isNodata(J, I)) {
        tempFloat = -1;
        flowDir.setData(J, I, tempFloat);
    }

    if (KD > 0)//We have a flow direction.  Calculate the Angle and save/write it.
    {
        tempFloat = (float) (ANGC[KD]*(PI / 2) + ANGF[KD] * ANGLE[KD]); //Calculate the Angle
        if (tempFloat >= 0.0)//Make sure the angle is positive
            flowDir.setData(J, I, tempFloat); //set the angle in the flowPartition
    }
}